diff --git a/.gitignore b/.gitignore index 4cb473b..be0abd9 100644 --- a/.gitignore +++ b/.gitignore @@ -1,2 +1,4 @@ # Project exclude paths -/frontend/node_modules/ \ No newline at end of file +/frontend/node_modules/ +.idea +venv \ No newline at end of file diff --git a/backend/apis/__init__.py b/backend/apis/__init__.py index c9dedc7..0d7aa35 100755 --- a/backend/apis/__init__.py +++ b/backend/apis/__init__.py @@ -1,18 +1,20 @@ from flask import Blueprint from flask_restplus import Api -from .epitope import api as epitope_api +from .ufl import api as ufl +from .analyze_file import api as analyze_file enable_doc = True api_blueprint = Blueprint('api', __name__) if enable_doc: - api = Api(title='ViruSurf API', version='1.0', description='TODO', ) + api = Api(title='UFL API', version='1.0', description='TODO', ) else: - api = Api(title='ViruSurf API', version='1.0', description='TODO', doc=False) + api = Api(title='UFL API', version='1.0', description='TODO', doc=False) api.init_app(api_blueprint, add_specs=enable_doc) -api.add_namespace(epitope_api) +api.add_namespace(ufl) +api.add_namespace(analyze_file) diff --git a/backend/apis/analyze_file.py b/backend/apis/analyze_file.py new file mode 100644 index 0000000..6c05908 --- /dev/null +++ b/backend/apis/analyze_file.py @@ -0,0 +1,467 @@ +from __future__ import print_function +# %config Completer.use_jedi = False + +import requests +import io +import http.client +import json + +import pandas as pd +from collections import defaultdict +from Bio import SeqIO +from io import StringIO +from Bio import Align, Seq, pairwise2 +from Bio.Data import CodonTable +import numpy as np +import itertools +import collections +import logomaker +import tqdm +import psycopg2 +import matplotlib.pyplot as plt + +from ipywidgets import interact, interactive, fixed, interact_manual +import ipywidgets as widgets +from IPython.core.display import HTML + +from flask_restplus import Namespace, Resource + + +api = Namespace('analyze_file', description='analyze_file') + + +######################################################################################################## + +@api.route('/firstAnalysis') +class FieldList(Resource): + @api.doc('first_analysis') + def post(self): + payload = api.payload + file_csv = payload.get('fileCSV') + + metadata = defaultdict(dict) + file_csv = io.StringIO(file_csv) + file_csv.readline() + + for line in file_csv: + s = line.strip().split(",") + cluster = s[0] + seq_id = s[1] + data = s[2] + label = s[4] + value = s[5] + + metadata[seq_id]['cluster'] = cluster + metadata[seq_id]["date"] = data + metadata[seq_id][label] = value + + # metadata = pd.DataFrame(metadata).T + + all_metadata = {} + + for line in metadata.items(): + for key, value in line[1].items(): + if key not in all_metadata: + all_metadata[key] = [] + found = False + for item in all_metadata[key]: + if value == item['name']: + item['value'] = item['value'] + 1 + found = True + if not found: + all_metadata[key].append({'name': value, 'value': 1}) + # if key == 'cluster': + # sorted(all_metadata[key]) + # else: + # all_metadata[key].sort() + + return all_metadata + + +@api.route('/secondAnalysis') +class FieldList(Resource): + @api.doc('second_analysis') + def post(self): + payload = api.payload + file_csv = payload.get('fileCSV') + file_fasta = payload.get('fileFASTA') + + protein = 'Spike (surface glycoprotein)' + + metadata = defaultdict(dict) + file_csv = io.StringIO(file_csv) + file_csv.readline() + + for line in file_csv: + s = line.strip().split(",") + cluster = s[0] + seq_id = s[1] + data = s[2] + label = s[4] + value = s[5] + + metadata[seq_id]['cluster'] = cluster + metadata[seq_id]["date"] = data + metadata[seq_id][label] = value + + metadata = pd.DataFrame(metadata).T + + fasta_io = StringIO(file_fasta) + + fasta_sequences = SeqIO.parse(fasta_io, "fasta") + l_fasta = list(fasta_sequences) + + #reference = str(SeqIO.parse('ref_cov2.fasta', 'fasta').__next__().seq).lower() + + spike_start, spike_stop, spike_aa = 21563, 25384, "MFVFLVLLPLVSSQCVNLTTRTQLPPAYTNSFTRGVYYPDKVFRSSVLHSTQDLFLPFFSNVTWFHAIHVSGTNGTKRFDNPVLPFNDGVYFASTEKSNIIRGWIFGTTLDSKTQSLLIVNNATNVVIKVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYVSQPFLMDLEGKQGNFKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNENGTITDAVDCALDPLSETKCTLKSFTVEKGIYQTSNFRVQPTESIVRFPNITNLCPFGEVFNATRFASVYAWNRKRISNCVADYSVLYNSASFSTFKCYGVSPTKLNDLCFTNVYADSFVIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIAWNSNNLDSKVGGNYNYLYRLFRKSNLKPFERDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNFNFNGLTGTGVLTESNKKFLPFQQFGRDIADTTDAVRDPQTLEILDITPCSFGGVSVITPGTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEILPVSMTKTSVDCTMYICGDSTECSNLLLQYGSFCTQLNRALTGIAVEQDKNTQEVFAQVKQIYKTPPIKDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYTSALLAGTITSGWTFGAGAALQIPFAMQMAYRFNGIGVTQNVLYENQKLIANQFNSAIGKIQDSLSSTASALGKLQDVVNQNAQALNTLVKQLSSNFGAISSVLNDILSRLDKVEAEVQIDRLITGRLQSLQTYVTQQLIRAAEIRASANLAATKMSECVLGQSKRVDFCGKGYHLMSFPQSAPHGVVFLHVTYVPAQEKNFTTAPAICHDGKAHFPREGVFVSNGTHWFVTQRNFYEPQIITTDNTFVSGNCDVVIGIVNNTVYDPLQPELDSFKEELDKYFKNHTSPDVDLGDISGINASVVNIQKEIDRLNEVAKNLNESLIDLQELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLKGCCSCGSCCKFDEDDSEPVLKGVKLHYT" + + table = CodonTable.ambiguous_dna_by_id[1] + conversion_table = table.__dict__['forward_table'].__dict__['forward_table'] + conversion_table['TAA'] = "*" + conversion_table['TGA'] = "*" + conversion_table['TAG'] = "*" + + nuc = set(['A', 'C', 'G', 'T']) + + def n2aa(codon): + if 'N' in codon: + return 'X' + elif '-' in codon: + return "#" + elif len(set(codon).difference(nuc)) > 0: + return "X" + else: + return conversion_table[codon] + + def nseq2aaseq(seq): + iseq = seq.replace("---", "") + i = 0 + aaseq = "" + while i < len(iseq): + aaseq += n2aa(iseq[i:i + 3]) + i += 3 + + return aaseq + + table = CodonTable.ambiguous_dna_by_id[1] + + mut_dataset = [] + seqs_1_epi = [] + seqs_2_epi = [] + + for s in tqdm.tqdm(l_fasta): + aa_spike = nseq2aaseq(str(s.seq[spike_start - 1:spike_stop])) + alignment_aa = pairwise2.align.globalms(spike_aa, aa_spike, 3, -1, -3, -1) + l_mut = [] + + seqs_1_epi.append(alignment_aa[0].seqB[1185 - 1:1202]) + seqs_2_epi.append(alignment_aa[0].seqB[16:24]) + + for i, r, s in zip(range(1, len(alignment_aa[0].seqA) + 1), alignment_aa[0].seqA, alignment_aa[0].seqB): + if r != s and s != "X": + l_mut.append((i, r, s)) + mut_dataset.append(l_mut) + + mut_dict = [{'id': i, + "mut": mut, + "fs_flag": len([x for x in mut if x[2] == '#']) > 0 + } for i, mut in zip([x.id for x in l_fasta], mut_dataset)] + + metadata['mut'] = pd.DataFrame(mut_dict).set_index('id').mut + + metadata['fs_flag'] = pd.DataFrame(mut_dict).set_index('id').fs_flag + + list_pairs = sorted(list( + set([tuple(x) for x in metadata[['cluster', 'lineage']].values]))) + + mut_stats = {} + for c, l in list_pairs: + rows_m = metadata[(metadata['cluster'] == c) & (metadata['lineage'] == l)] + samples = rows_m.shape[0] + + mut = list(rows_m['mut'].values) + mut_counts = collections.Counter([item for sublist in mut for item in sublist]) + + mut_stats[(c, l)] = (samples, mut_counts) + + url = 'http://geco.deib.polimi.it/virusurf_epitope/api/epitope/statisticsMutationsLineages' + + conn = http.client.HTTPConnection('geco.deib.polimi.it') + + headers = {'Content-type': 'application/json'} + + foo = list_pairs + json_data = json.dumps(foo) + + # conn.request('POST', '/virusurf_epitope/api/epitope/statisticsMutationsLineages', json_data, headers) + + conn.request('GET', '/virusurf_epitope/api/epitope/statisticsMutationsLineagesGET') + + response = conn.getresponse() + lineage_stats = response.read().decode() + + lineage_stats = json.loads(lineage_stats) + + # lineage_stats = requests.post(url, data=list_pairs) + # lineage_stats = lineage_stats.text + list_data_mut_table = [] + for (c, l), (n, cnt) in list(mut_stats.items()): + for m in cnt.keys(): + l1 = str(l) + m1 = str(m) + if l not in lineage_stats: + lineage_stats[l1] = {} + m2 = m1.replace(")", f", '{protein}')") + cnt_c = cnt[m] + frq_l = lineage_stats[l1].get(m2, 0) + frq_c = cnt_c / n + fc = frq_c / (frq_l + 0.000001) + + list_data_mut_table.append((c, l, m, cnt_c, frq_l, frq_c, fc)) + + mut_table = pd.DataFrame(list_data_mut_table, columns=["cluster", + "lineage", + 'mutation', + "# cluster", + "% lineage", + "% cluster", + "FC"]) + + def select_pair(c_l, fc): + c, l = tuple(c_l.split()) + res = mut_table[(mut_table['cluster'] == c) & (mut_table['lineage'] == l) & (mut_table['FC'] > fc)] + res = res[res.columns[2:]].reset_index(drop=True) + # display(res) + return res + + # interact(lambda x : select_pair(x), x=[c+" "+l for c,l in list_pairs]); + + # interactive(select_pair,c_l=[c + " " + l for c, l in list_pairs],fc=(0.0, 5.0, 0.5)) + + def select_cluster(c): + cluster = metadata[metadata['cluster'] == c] + mut_list = [item for sublist in list(cluster.mut) for item in sublist] + all_mut = set(mut_list) + all_lineages = collections.Counter(list(cluster['lineage'])) + num_sequences = cluster.shape[0] + epitopes = [(x, + x - 6, + x + 6, + spike_aa[x - 6 - 1:x + 6], + len([p for p, _, _ in mut_list if x - 6 <= p <= x + 6]), + len([p for p, _, _ in mut_list if x - 6 <= p <= x + 6]) / num_sequences, + o, + a + ) for x, o, a in all_mut] + + epitopes2 = [] + + for e in epitopes: + mut_lin_epitope = defaultdict(int) + for lin, cnt in all_lineages.items(): + mut_lin = [(perc * cnt / num_sequences, (p, o, a)) for (p, o, a), perc in lineage_stats[lin].items() + if e[1] <= p <= e[2]] + for perc, (p, o, a) in mut_lin: + mut_lin_epitope[f'{o}{p}{a}'] += perc + + epitopes2.append((e, + sorted( + list(mut_lin_epitope.items()), + key=lambda x: x[1], + reverse=True + ))) + + def format_mut(xs): + return "; ".join([f'{x[0]}:{x[1] * 100:.1f}%' for x in xs]) + + res = pd.DataFrame([{"seq": e[0][3], + "cluster_mut": f'{e[0][-2]}{e[0][0]}{e[0][-1]}', + "#cluster": e[0][4], + "%cluster": int(e[0][5] * 10000) / 100, + "avg. mut lineage(s)": format_mut(e[1]) + } for e in epitopes2]) + + res = res.sort_values('#cluster', ascending=False).reset_index(drop=True) + # display(res) + + return res + + # interactive(select_cluster, c=sorted(set([c for c, l in list_pairs]))) + + #epitopes = requests.get("http://geco.deib.polimi.it/virusurf_epitope/api/epitope/allEpitopes") + #epitopes = epitopes.json() + + #epitopes = json.loads(epitopes) + + conn = http.client.HTTPConnection('geco.deib.polimi.it') + + conn.request('GET', '/virusurf_epitope/api/epitope/allEpitopes') + + response_epi = conn.getresponse() + epitopes = response_epi.read().decode() + + epitopes = json.loads(epitopes) + + epitopes = pd.DataFrame.from_dict(epitopes, orient='columns') + + selected_mut = mut_table[(mut_table['# cluster'] > 1) & (mut_table['% lineage'] < 0.01)] + + def enrich_mutations(m): + selected_epitopes = epitopes[ + (epitopes['epi_frag_annotation_start'] <= m[0]) & (epitopes['epi_frag_annotation_stop'] >= m[0])] + selected_linear = selected_epitopes[selected_epitopes.is_linear] + selected_nonlin = selected_epitopes[~selected_epitopes.is_linear] + s_min = selected_linear.epi_annotation_start.min() + s_max = selected_linear.epi_annotation_stop.max() + epi_seq = spike_aa[s_min - 1:s_max] + publications_linear = list(set(list(itertools.chain(*list(selected_linear.pubs))))) + publications_nonlin = list(set(list(itertools.chain(*list(selected_nonlin.pubs))))) + + return (s_min, + s_max, + epi_seq, + selected_linear.shape[0], + selected_nonlin.shape[0], + publications_linear, + publications_nonlin, + len(publications_linear), + len(publications_nonlin)) + + mut_table[["epi_start", "epi_stop", "epi_seq", "#linear", "#non-linear", "pubs linear", "pubs non-linear", + "#pubs linear", "#pubs non-linear"]] = pd.DataFrame( + mut_table.mutation.apply(enrich_mutations).tolist(), index=mut_table.index) + + def create_filter(m): + return lambda x: m in x + + def find_sequences(x): + c = x.cluster + m = x.mutation + l = x.lineage + return list(metadata[metadata.mut.apply(create_filter(m)) & (metadata.cluster == c) & ( + metadata.lineage == l)].index) + + mut_table['sequences'] = mut_table.apply(find_sequences, axis=1) + + annotations = pd.read_csv("/Users/LucaCillo/Desktop/UFL project/backend/apis/spike_annotations.tsv", delimiter='\t') + + def find_annotation(m): + return list(annotations[(annotations.Start <= m[0]) & (annotations.Stop >= m[0])].Annotation) + + mut_table['annotations'] = mut_table.mutation.apply(find_annotation) + + res = mut_table + + # res = res.to_json(orient='records', lines=True).splitlines() + + list_dict = [] + for index, row in list(res.iterrows()): + list_dict.append(dict(row)) + + + # list_dict = [{'cluster': 'c101', 'lineage': 'B.1', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.9960946785750671, '% cluster': 1.0, 'FC': 1.0039196249004092, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GP-5671/2020|EPI_ISL_700516|2020-05-14|Africa', 'hCoV-19/South_Africa/KRISP-K004596/2020|EPI_ISL_660626|2020-11-07|Africa', 'hCoV-19/South_Africa/KRISP-K003709/2020|EPI_ISL_602889|2020-10-05|Africa', 'hCoV-19/South_Africa/KRISP-K002882/2020|EPI_ISL_602694|2020-09-03|Africa', 'hCoV-19/South_Africa/KRISP-K002818/2020|EPI_ISL_602639|2020-09-02|Africa', 'hCoV-19/South_Africa/KRISP-K002733/2020|EPI_ISL_529731|2020-08-16|Africa', 'hCoV-19/South_Africa/KRISP-K002472/2020|EPI_ISL_518051|2020-07-14|Africa'], 'annotations': []}, {'cluster': 'c103', 'lineage': 'B.1.243', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.9984247834077186, '% cluster': 1.0, 'FC': 1.001576698657469, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/USA/HI-H200472/2020|EPI_ISL_753015|2020-10-10|NorthAmerica', 'hCoV-19/USA/HI-H200284/2020|EPI_ISL_752843|2020-09-10|NorthAmerica', 'hCoV-19/USA/HI-H200329/2020|EPI_ISL_752887|2020-08-20|NorthAmerica', 'hCoV-19/USA/HI-H200259/2020|EPI_ISL_752818|2020-08-25|NorthAmerica', 'hCoV-19/USA/HI-H200355/2020|EPI_ISL_752911|2020-09-23|NorthAmerica', 'hCoV-19/USA/TX-HMH-MCoV-12473/2020|EPI_ISL_790355|2020-09-28|NorthAmerica', 'hCoV-19/USA/TX-HMH-MCoV-15230/2020|EPI_ISL_786714|2020-10-19|NorthAmerica'], 'annotations': []}, {'cluster': 'c103', 'lineage': 'B.1.243', 'mutation': (681, 'P', 'H'), '# cluster': 7, '% lineage': 0.5760042005775794, '% cluster': 1.0, 'FC': 1.7360954362864554, 'epi_start': 647, 'epi_stop': 698, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAYTMS', '#linear': 42, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 12, '#pubs non-linear': 0, 'sequences': ['hCoV-19/USA/HI-H200472/2020|EPI_ISL_753015|2020-10-10|NorthAmerica', 'hCoV-19/USA/HI-H200284/2020|EPI_ISL_752843|2020-09-10|NorthAmerica', 'hCoV-19/USA/HI-H200329/2020|EPI_ISL_752887|2020-08-20|NorthAmerica', 'hCoV-19/USA/HI-H200259/2020|EPI_ISL_752818|2020-08-25|NorthAmerica', 'hCoV-19/USA/HI-H200355/2020|EPI_ISL_752911|2020-09-23|NorthAmerica', 'hCoV-19/USA/TX-HMH-MCoV-12473/2020|EPI_ISL_790355|2020-09-28|NorthAmerica', 'hCoV-19/USA/TX-HMH-MCoV-15230/2020|EPI_ISL_786714|2020-10-19|NorthAmerica'], 'annotations': []}, {'cluster': 'c114', 'lineage': 'B.1.240', 'mutation': (614, 'D', 'G'), '# cluster': 11, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/USA/MN-MDH-1821/2020|EPI_ISL_602956|2020-08-09|NorthAmerica', 'hCoV-19/USA/AZ-TG547355/2020|EPI_ISL_695501|2020-07-07|NorthAmerica', 'hCoV-19/USA/TX-HMH-MCoV-15790/2020|EPI_ISL_785474|2020-07-10|NorthAmerica', 'hCoV-19/USA/LA-EVTL842/2020|EPI_ISL_653533|2020-07-28|NorthAmerica', 'hCoV-19/USA/TX-HMH-MCoV-13212/2020|EPI_ISL_788363|2020-08-25|NorthAmerica', 'hCoV-19/USA/PA-MGEL-00700/2020|EPI_ISL_682031|2020-10-06|NorthAmerica', 'hCoV-19/USA/PA-MGEL-00714/2020|EPI_ISL_682041|2020-10-13|NorthAmerica', 'hCoV-19/USA/LA-CDC-2-3693761/2020|EPI_ISL_747072|2020-11-04|NorthAmerica', 'hCoV-19/USA/AZ-TG456402/2020|EPI_ISL_695043|2020-06-26|NorthAmerica', 'hCoV-19/England/MILK-9A88DC/2020|EPI_ISL_549430|2020-09-01|Europe', 'hCoV-19/USA/MD-MDH-0292/2020|EPI_ISL_629072|2020-10-13|NorthAmerica'], 'annotations': []}, {'cluster': 'c114', 'lineage': 'B.1.240', 'mutation': (785, 'V', 'L'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.09090909090909091, 'FC': 90909.09090909091, 'epi_start': 760, 'epi_stop': 814, 'epi_seq': 'CTQLNRALTGIAVEQDKNTQEVFAQVKQIYKTPPIKDFGGFNFSQILPDPSKPSK', '#linear': 37, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 12, '#pubs non-linear': 0, 'sequences': ['hCoV-19/USA/LA-EVTL842/2020|EPI_ISL_653533|2020-07-28|NorthAmerica'], 'annotations': []}, {'cluster': 'c114', 'lineage': 'B.1.240', 'mutation': (1118, 'D', 'A'), '# cluster': 1, '% lineage': 0.0040941658137154556, '% cluster': 0.09090909090909091, 'FC': 22.199123318674868, 'epi_start': 1105, 'epi_stop': 1131, 'epi_seq': 'TQRNFYEPQIITTDNTFVSGNCDVVIG', '#linear': 17, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/USA/LA-CDC-2-3693761/2020|EPI_ISL_747072|2020-11-04|NorthAmerica'], 'annotations': []}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (18, 'L', 'F'), '# cluster': 8, '% lineage': 0.37103594080338265, '% cluster': 1.0, 'FC': 2.6951494313066613, 'epi_start': 1, 'epi_stop': 34, 'epi_seq': 'MFVFLVLLPLVSSQCVNLTTRTQLPPAYTNSFTR', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 4, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 8, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 8, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 8, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 8, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 8, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 8, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 8, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 8, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 8, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': []}, {'cluster': 'c12', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 8, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-392/2020|EPI_ISL_745156|2020-12-02|Africa', 'hCoV-19/Germany/BW-ChVir22275/2021|EPI_ISL_875344|2021-01-15|Europe', 'hCoV-19/South_Africa/Tygerberg-406/2020|EPI_ISL_745160|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-405/2020|EPI_ISL_745130|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-396/2020|EPI_ISL_745157|2020-12-03|Africa', 'hCoV-19/South_Africa/Tygerberg-408/2020|EPI_ISL_745161|2020-12-04|Africa', 'hCoV-19/South_Africa/Tygerberg-390/2020|EPI_ISL_745155|2020-12-02|Africa', 'hCoV-19/South_Africa/Tygerberg-429/2020|EPI_ISL_745167|2020-12-06|Africa'], 'annotations': []}, {'cluster': 'c122', 'lineage': 'B.1', 'mutation': (614, 'D', 'G'), '# cluster': 8, '% lineage': 0.9960946785750671, '% cluster': 1.0, 'FC': 1.0039196249004092, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002314/2020|EPI_ISL_515690|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002315/2020|EPI_ISL_515691|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002317/2020|EPI_ISL_515693|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002342/2020|EPI_ISL_515715|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002260/2020|EPI_ISL_515645|2020-07-16|Africa', 'hCoV-19/South_Africa/KRISP-K002320/2020|EPI_ISL_515696|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K001063/2020|EPI_ISL_509319|2020-07-03|Africa', 'hCoV-19/South_Africa/R13300-20/2020|EPI_ISL_622909|2020-06-30|Africa'], 'annotations': []}, {'cluster': 'c122', 'lineage': 'B.1', 'mutation': (1134, 'N', 'H'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.25, 'FC': 250000.0, 'epi_start': 1121, 'epi_stop': 1147, 'epi_seq': 'FVSGNCDVVIGIVNNTVYDPLQPELDS', '#linear': 9, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 5, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002315/2020|EPI_ISL_515691|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002317/2020|EPI_ISL_515693|2020-07-22|Africa'], 'annotations': []}, {'cluster': 'c125', 'lineage': 'B.1.381', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K000636/2020|EPI_ISL_509286|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K000574/2020|EPI_ISL_509230|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K000651/2020|EPI_ISL_509295|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K001092/2020|EPI_ISL_509343|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K000654/2020|EPI_ISL_509297|2020-07-13|Africa'], 'annotations': []}, {'cluster': 'c126', 'lineage': 'B.1.381', 'mutation': (614, 'D', 'G'), '# cluster': 6, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/LR00080/2020|EPI_ISL_514391|2020-07-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1648/2020|EPI_ISL_700493|2020-08-17|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2284/2020|EPI_ISL_700577|2020-08-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0024/2020|EPI_ISL_640025|2020-08-14|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1772/2020|EPI_ISL_640108|2020-09-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1695/2020|EPI_ISL_700507|2020-08-19|Africa'], 'annotations': []}, {'cluster': 'c126', 'lineage': 'B.1.381', 'mutation': (1163, 'D', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.16666666666666666, 'FC': 166666.66666666666, 'epi_start': 1135, 'epi_stop': 1184, 'epi_seq': 'NTVYDPLQPELDSFKEELDKYFKNHTSPDVDLGDISGINASVVNIQKEID', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1695/2020|EPI_ISL_700507|2020-08-19|Africa'], 'annotations': ['heptapeptide repeat sequence 2']}, {'cluster': 'c128', 'lineage': 'B.1.381', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-0690/2020|EPI_ISL_700476|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0960/2020|EPI_ISL_700569|2020-10-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0958/2020|EPI_ISL_700519|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1371/2020|EPI_ISL_700583|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1368/2020|EPI_ISL_700474|2020-11-12|Africa'], 'annotations': []}, {'cluster': 'c128', 'lineage': 'B.1.381', 'mutation': (701, 'A', 'V'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-0690/2020|EPI_ISL_700476|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0960/2020|EPI_ISL_700569|2020-10-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0958/2020|EPI_ISL_700519|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1371/2020|EPI_ISL_700583|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1368/2020|EPI_ISL_700474|2020-11-12|Africa'], 'annotations': []}, {'cluster': 'c129', 'lineage': 'B.1.381', 'mutation': (218, 'Q', 'E'), '# cluster': 10, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 200, 'epi_stop': 234, 'epi_seq': 'YFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGIN', '#linear': 30, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065'], '#pubs linear': 12, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1874/2020|EPI_ISL_640118|2020-09-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2030/2020|EPI_ISL_640122|2020-09-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1026/2020|EPI_ISL_700497|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0657/2020|EPI_ISL_700538|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0663/2020|EPI_ISL_700557|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0636/2020|EPI_ISL_700556|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1027/2020|EPI_ISL_700533|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0641/2020|EPI_ISL_700536|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7004-KRISP/2020|EPI_ISL_696468|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7030-KRISP/2020|EPI_ISL_696509|2020-11-24|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c129', 'lineage': 'B.1.381', 'mutation': (614, 'D', 'G'), '# cluster': 10, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1874/2020|EPI_ISL_640118|2020-09-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2030/2020|EPI_ISL_640122|2020-09-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1026/2020|EPI_ISL_700497|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0657/2020|EPI_ISL_700538|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0663/2020|EPI_ISL_700557|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0636/2020|EPI_ISL_700556|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1027/2020|EPI_ISL_700533|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0641/2020|EPI_ISL_700536|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7004-KRISP/2020|EPI_ISL_696468|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7030-KRISP/2020|EPI_ISL_696509|2020-11-24|Africa'], 'annotations': []}, {'cluster': 'c129', 'lineage': 'B.1.381', 'mutation': (69, 'H', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.1, 'FC': 100000.00000000001, 'epi_start': 54, 'epi_stop': 85, 'epi_seq': 'LFLPFFSNVTWFHAIHVSGTNGTKRFDNPVLP', '#linear': 12, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065'], '#pubs linear': 6, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-0636/2020|EPI_ISL_700556|2020-10-19|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c129', 'lineage': 'B.1.381', 'mutation': (946, 'G', 'R'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.1, 'FC': 100000.00000000001, 'epi_start': 906, 'epi_stop': 968, 'epi_seq': 'FNGIGVTQNVLYENQKLIANQFNSAIGKIQDSLSSTASALGKLQDVVNQNAQALNTLVKQLSS', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-7004-KRISP/2020|EPI_ISL_696468|2020-11-18|Africa'], 'annotations': ['heptapeptide repeat sequence 1']}, {'cluster': 'c131', 'lineage': 'B.1.237', 'mutation': (222, 'A', 'V'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/Tygerberg-453/2020|EPI_ISL_745140|2020-12-07|Africa', 'hCoV-19/South_Africa/Tygerberg-432/2020|EPI_ISL_745190|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1391-KRISP/2020|EPI_ISL_696464|2020-11-19|Africa', 'hCoV-19/South_Africa/N00362/2020|EPI_ISL_712078|2020-09-29|Africa', 'hCoV-19/South_Africa/N00360/2020|EPI_ISL_712077|2020-09-29|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c131', 'lineage': 'B.1.237', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/Tygerberg-453/2020|EPI_ISL_745140|2020-12-07|Africa', 'hCoV-19/South_Africa/Tygerberg-432/2020|EPI_ISL_745190|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1391-KRISP/2020|EPI_ISL_696464|2020-11-19|Africa', 'hCoV-19/South_Africa/N00362/2020|EPI_ISL_712078|2020-09-29|Africa', 'hCoV-19/South_Africa/N00360/2020|EPI_ISL_712077|2020-09-29|Africa'], 'annotations': []}, {'cluster': 'c131', 'lineage': 'B.1.237', 'mutation': (701, 'A', 'V'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-453/2020|EPI_ISL_745140|2020-12-07|Africa', 'hCoV-19/South_Africa/Tygerberg-432/2020|EPI_ISL_745190|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1391-KRISP/2020|EPI_ISL_696464|2020-11-19|Africa', 'hCoV-19/South_Africa/N00362/2020|EPI_ISL_712078|2020-09-29|Africa', 'hCoV-19/South_Africa/N00360/2020|EPI_ISL_712077|2020-09-29|Africa'], 'annotations': []}, {'cluster': 'c131', 'lineage': 'B.1.237', 'mutation': (676, 'T', 'I'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.4, 'FC': 400000.00000000006, 'epi_start': 647, 'epi_stop': 695, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAY', '#linear': 22, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/N00362/2020|EPI_ISL_712078|2020-09-29|Africa', 'hCoV-19/South_Africa/N00360/2020|EPI_ISL_712077|2020-09-29|Africa'], 'annotations': []}, {'cluster': 'c133', 'lineage': 'A', 'mutation': (453, 'Y', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.16666666666666666, 'FC': 166666.66666666666, 'epi_start': 425, 'epi_stop': 467, 'epi_seq': 'LPDDFTGCVIAWNSNNLDSKVGGNYNYLYRLFRKSNLKPFERD', '#linear': 57, '#non-linear': 35, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037085', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 16, '#pubs non-linear': 21, 'sequences': ['hCoV-19/South_Africa/KRISP-0267/2020|EPI_ISL_482854|2020-06-17|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c133', 'lineage': 'A', 'mutation': (809, 'P', 'S'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.3333333333333333, 'FC': 333333.3333333333, 'epi_start': 779, 'epi_stop': 837, 'epi_seq': 'QEVFAQVKQIYKTPPIKDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQY', '#linear': 35, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 14, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0267/2020|EPI_ISL_482854|2020-06-17|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2931/2020|EPI_ISL_700481|2020-05-09|Africa'], 'annotations': []}, {'cluster': 'c133', 'lineage': 'A', 'mutation': (946, 'G', 'R'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.3333333333333333, 'FC': 333333.3333333333, 'epi_start': 906, 'epi_stop': 968, 'epi_seq': 'FNGIGVTQNVLYENQKLIANQFNSAIGKIQDSLSSTASALGKLQDVVNQNAQALNTLVKQLSS', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0267/2020|EPI_ISL_482854|2020-06-17|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2931/2020|EPI_ISL_700481|2020-05-09|Africa'], 'annotations': ['heptapeptide repeat sequence 1']}, {'cluster': 'c133', 'lineage': 'A', 'mutation': (330, 'P', 'S'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.3333333333333333, 'FC': 333333.3333333333, 'epi_start': 313, 'epi_stop': 359, 'epi_seq': 'YQTSNFRVQPTESIVRFPNITNLCPFGEVFNATRFASVYAWNRKRIS', '#linear': 16, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/United_Arab_Emirates/0891/2020|EPI_ISL_699029|2020-06-25|Asia', 'hCoV-19/United_Arab_Emirates/0720/2020|EPI_ISL_698871|2020-05-19|Asia'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c133', 'lineage': 'A', 'mutation': (1176, 'V', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.16666666666666666, 'FC': 166666.66666666666, 'epi_start': 1155, 'epi_stop': 1207, 'epi_seq': 'YFKNHTSPDVDLGDISGINASVVNIQKEIDRLNEVAKNLNESLIDLQELGKYE', '#linear': 32, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/United_Arab_Emirates/0891/2020|EPI_ISL_699029|2020-06-25|Asia'], 'annotations': ['heptapeptide repeat sequence 2']}, {'cluster': 'c133', 'lineage': 'A', 'mutation': (684, 'A', 'S'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.16666666666666666, 'FC': 166666.66666666666, 'epi_start': 647, 'epi_stop': 726, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 41, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 12, '#pubs non-linear': 0, 'sequences': ['hCoV-19/United_Arab_Emirates/0720/2020|EPI_ISL_698871|2020-05-19|Asia'], 'annotations': []}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (18, 'L', 'F'), '# cluster': 5, '% lineage': 0.37103594080338265, '% cluster': 1.0, 'FC': 2.6951494313066613, 'epi_start': 1, 'epi_stop': 34, 'epi_seq': 'MFVFLVLLPLVSSQCVNLTTRTQLPPAYTNSFTR', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 4, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 5, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 5, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 5, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 5, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 5, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 5, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': []}, {'cluster': 'c14', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 5, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-DG01843206/2020|EPI_ISL_736951|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01843213/2020|EPI_ISL_736952|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K005311/2020|EPI_ISL_678604|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-DG01843056/2020|EPI_ISL_736949|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-DG01842216/2020|EPI_ISL_736947|2020-11-25|Africa'], 'annotations': []}, {'cluster': 'c149', 'lineage': 'B.1.1.254', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002681/2020|EPI_ISL_535545|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K002673/2020|EPI_ISL_535539|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K002684/2020|EPI_ISL_535547|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K001344/2020|EPI_ISL_515829|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002545/2020|EPI_ISL_535415|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K002678/2020|EPI_ISL_535542|2020-08-03|Africa', 'hCoV-19/South_Africa/KRISP-K002867/2020|EPI_ISL_602681|2020-08-29|Africa'], 'annotations': []}, {'cluster': 'c149', 'lineage': 'B.1.1.254', 'mutation': (809, 'P', 'L'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.14285714285714285, 'FC': 142857.14285714287, 'epi_start': 779, 'epi_stop': 837, 'epi_seq': 'QEVFAQVKQIYKTPPIKDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQY', '#linear': 35, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 14, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002867/2020|EPI_ISL_602681|2020-08-29|Africa'], 'annotations': []}, {'cluster': 'c151', 'lineage': 'B.1.1.254', 'mutation': (614, 'D', 'G'), '# cluster': 8, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K000655/2020|EPI_ISL_509298|2020-07-12|Africa', 'hCoV-19/South_Africa/KRISP-K003322/2020|EPI_ISL_602715|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K002816/2020|EPI_ISL_602637|2020-08-21|Africa', 'hCoV-19/South_Africa/KRISP-0538/2020|EPI_ISL_498080|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-K002903/2020|EPI_ISL_602714|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K003689/2020|EPI_ISL_602871|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K003730/2020|EPI_ISL_602908|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K003733/2020|EPI_ISL_602911|2020-10-06|Africa'], 'annotations': []}, {'cluster': 'c151', 'lineage': 'B.1.1.254', 'mutation': (522, 'A', 'E'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.125, 'FC': 125000.0, 'epi_start': 499, 'epi_stop': 541, 'epi_seq': 'PTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 17, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003733/2020|EPI_ISL_602911|2020-10-06|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c153', 'lineage': 'B.1', 'mutation': (614, 'D', 'G'), '# cluster': 2, '% lineage': 0.9960946785750671, '% cluster': 1.0, 'FC': 1.0039196249004092, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-2092/2020|EPI_ISL_640084|2020-09-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2093/2020|EPI_ISL_640085|2020-09-25|Africa'], 'annotations': []}, {'cluster': 'c153', 'lineage': 'B.1.1.254', 'mutation': (614, 'D', 'G'), '# cluster': 17, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004037/2020|EPI_ISL_635018|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2085/2020|EPI_ISL_640128|2020-09-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3519/2020|EPI_ISL_640140|2020-10-10|Africa', 'hCoV-19/South_Africa/KRISP-K004315/2020|EPI_ISL_660192|2020-10-27|Africa', 'hCoV-19/South_Africa/KRISP-K004553/2020|EPI_ISL_660250|2020-10-27|Africa', 'hCoV-19/South_Africa/KRISP-K004536/2020|EPI_ISL_660234|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004330/2020|EPI_ISL_660206|2020-10-24|Africa', 'hCoV-19/South_Africa/KRISP-K004325/2020|EPI_ISL_660201|2020-10-27|Africa', 'hCoV-19/South_Africa/KRISP-K004552/2020|EPI_ISL_660249|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2022/2020|EPI_ISL_640119|2020-09-14|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3522/2020|EPI_ISL_640141|2020-10-11|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920916/2020|EPI_ISL_736927|2020-12-07|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920913/2020|EPI_ISL_736995|2020-12-07|Africa', 'hCoV-19/South_Africa/KRISP-K004723-CS1/2020|EPI_ISL_660256|2020-11-18|Africa', 'hCoV-19/South_Africa/KRISP-K004534-CS1/2020|EPI_ISL_660232|2020-11-17|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3468/2020|EPI_ISL_640133|2020-10-01|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3469/2020|EPI_ISL_640134|2020-10-01|Africa'], 'annotations': []}, {'cluster': 'c153', 'lineage': 'B.1.1.254', 'mutation': (1237, 'M', 'I'), '# cluster': 6, '% lineage': 0.0, '% cluster': 0.35294117647058826, 'FC': 352941.17647058825, 'epi_start': 1202, 'epi_stop': 1255, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLKGCCSCGSCCK', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-3522/2020|EPI_ISL_640141|2020-10-11|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920916/2020|EPI_ISL_736927|2020-12-07|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920913/2020|EPI_ISL_736995|2020-12-07|Africa', 'hCoV-19/South_Africa/KRISP-K004723-CS1/2020|EPI_ISL_660256|2020-11-18|Africa', 'hCoV-19/South_Africa/KRISP-K004534-CS1/2020|EPI_ISL_660232|2020-11-17|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3469/2020|EPI_ISL_640134|2020-10-01|Africa'], 'annotations': ['TM domain', 'cytoplasm domain']}, {'cluster': 'c153', 'lineage': 'B.1.1.254', 'mutation': (701, 'A', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.058823529411764705, 'FC': 58823.529411764706, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-MDSH920916/2020|EPI_ISL_736927|2020-12-07|Africa'], 'annotations': []}, {'cluster': 'c153', 'lineage': 'B.1.1.254', 'mutation': (1208, 'Q', 'H'), '# cluster': 4, '% lineage': 0.0, '% cluster': 0.23529411764705882, 'FC': 235294.11764705883, 'epi_start': 1193, 'epi_stop': 1244, 'epi_seq': 'LNESLIDLQELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCL', '#linear': 27, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037576', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037085', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037941', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 17, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-MDSH920916/2020|EPI_ISL_736927|2020-12-07|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920913/2020|EPI_ISL_736995|2020-12-07|Africa', 'hCoV-19/South_Africa/KRISP-K004723-CS1/2020|EPI_ISL_660256|2020-11-18|Africa', 'hCoV-19/South_Africa/KRISP-K004534-CS1/2020|EPI_ISL_660232|2020-11-17|Africa'], 'annotations': ['heptapeptide repeat sequence 2']}, {'cluster': 'c153', 'lineage': 'B.1.1.269', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 0.996742671009772, '% cluster': 1.0, 'FC': 1.0032669673105916, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004586/2020|EPI_ISL_660616|2020-11-05|Africa'], 'annotations': []}, {'cluster': 'c163', 'lineage': 'B.1.1.119', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K001080/2020|EPI_ISL_509334|2020-07-01|Africa', 'hCoV-19/South_Africa/KRISP-K001098/2020|EPI_ISL_509347|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001100/2020|EPI_ISL_509349|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K002829/2020|EPI_ISL_602649|2020-09-01|Africa', 'hCoV-19/South_Africa/KRISP-K002805/2020|EPI_ISL_529799|2020-08-24|Africa'], 'annotations': []}, {'cluster': 'c163', 'lineage': 'B.1.1.119', 'mutation': (178, 'D', 'N'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.4, 'FC': 400000.00000000006, 'epi_start': 161, 'epi_stop': 194, 'epi_seq': 'SSANNCTFEYVSQPFLMDLEGKQGNFKNLREFVF', '#linear': 32, '#non-linear': 3, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1036944'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K002829/2020|EPI_ISL_602649|2020-09-01|Africa', 'hCoV-19/South_Africa/KRISP-K002805/2020|EPI_ISL_529799|2020-08-24|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c176', 'lineage': 'B.1.1.117', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002398/2020|EPI_ISL_515762|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K004538/2020|EPI_ISL_660236|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K003490/2020|EPI_ISL_602820|2020-09-14|Africa', 'hCoV-19/South_Africa/KRISP-K003323/2020|EPI_ISL_602716|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K003327/2020|EPI_ISL_602720|2020-09-07|Africa'], 'annotations': []}, {'cluster': 'c176', 'lineage': 'B.1.1.117', 'mutation': (688, 'A', 'V'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 647, 'epi_stop': 726, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 41, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002398/2020|EPI_ISL_515762|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K004538/2020|EPI_ISL_660236|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K003490/2020|EPI_ISL_602820|2020-09-14|Africa', 'hCoV-19/South_Africa/KRISP-K003323/2020|EPI_ISL_602716|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K003327/2020|EPI_ISL_602720|2020-09-07|Africa'], 'annotations': []}, {'cluster': 'c176', 'lineage': 'B.1.1.117', 'mutation': (274, 'T', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.2, 'FC': 200000.00000000003, 'epi_start': 240, 'epi_stop': 302, 'epi_seq': 'TLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNENGTITDAVDCALDPLSETKCT', '#linear': 21, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037942', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037949', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037363', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037085', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1037935', 'http://www.iedb.org/reference/1038013', 'http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1037576', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037971', 'http://www.iedb.org/reference/1037941', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 23, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004538/2020|EPI_ISL_660236|2020-10-18|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c182', 'lineage': 'B.1.1.119', 'mutation': (154, 'E', 'Q'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.5, 'FC': 500000.0, 'epi_start': 129, 'epi_stop': 171, 'epi_seq': 'KVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYV', '#linear': 15, '#non-linear': 4, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 8, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K003521/2020|EPI_ISL_602840|2020-09-27|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c182', 'lineage': 'B.1.1.119', 'mutation': (522, 'A', 'S'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.5, 'FC': 500000.0, 'epi_start': 499, 'epi_stop': 541, 'epi_seq': 'PTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 17, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003521/2020|EPI_ISL_602840|2020-09-27|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c182', 'lineage': 'B.1.1.119', 'mutation': (614, 'D', 'G'), '# cluster': 2, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K003521/2020|EPI_ISL_602840|2020-09-27|Africa', 'hCoV-19/South_Africa/KRISP-K005323/2020|EPI_ISL_678613|2020-11-17|Africa'], 'annotations': []}, {'cluster': 'c182', 'lineage': 'B.1.1.119', 'mutation': (834, 'I', 'V'), '# cluster': 2, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 795, 'epi_stop': 874, 'epi_seq': 'KDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYT', '#linear': 30, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003521/2020|EPI_ISL_602840|2020-09-27|Africa', 'hCoV-19/South_Africa/KRISP-K005323/2020|EPI_ISL_678613|2020-11-17|Africa'], 'annotations': []}, {'cluster': 'c182', 'lineage': 'B.1.1.220', 'mutation': (614, 'D', 'G'), '# cluster': 13, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004587/2020|EPI_ISL_660617|2020-11-06|Africa', 'hCoV-19/South_Africa/KRISP-K004598/2020|EPI_ISL_660628|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004045/2020|EPI_ISL_635024|2020-10-15|Africa', 'hCoV-19/South_Africa/KRISP-K004546/2020|EPI_ISL_660243|2020-10-27|Africa', 'hCoV-19/South_Africa/KRISP-K004649/2020|EPI_ISL_660662|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K004602/2020|EPI_ISL_660631|2020-11-06|Africa', 'hCoV-19/South_Africa/KRISP-K005309/2020|EPI_ISL_678602|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004627/2020|EPI_ISL_660643|2020-11-01|Africa', 'hCoV-19/South_Africa/KRISP-CH01110731/2020|EPI_ISL_736926|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K004606/2020|EPI_ISL_660632|2020-11-08|Africa', 'hCoV-19/South_Africa/KRISP-K004635/2020|EPI_ISL_660651|2020-11-02|Africa', 'hCoV-19/South_Africa/KRISP-K004339/2020|EPI_ISL_660215|2020-10-28|Africa', 'hCoV-19/South_Africa/KRISP-K004609/2020|EPI_ISL_660634|2020-11-08|Africa'], 'annotations': []}, {'cluster': 'c182', 'lineage': 'B.1.1.220', 'mutation': (154, 'E', 'Q'), '# cluster': 12, '% lineage': 0.0, '% cluster': 0.9230769230769231, 'FC': 923076.9230769231, 'epi_start': 129, 'epi_stop': 171, 'epi_seq': 'KVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYV', '#linear': 15, '#non-linear': 4, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 8, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004598/2020|EPI_ISL_660628|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004045/2020|EPI_ISL_635024|2020-10-15|Africa', 'hCoV-19/South_Africa/KRISP-K004546/2020|EPI_ISL_660243|2020-10-27|Africa', 'hCoV-19/South_Africa/KRISP-K004649/2020|EPI_ISL_660662|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K004602/2020|EPI_ISL_660631|2020-11-06|Africa', 'hCoV-19/South_Africa/KRISP-K005309/2020|EPI_ISL_678602|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004627/2020|EPI_ISL_660643|2020-11-01|Africa', 'hCoV-19/South_Africa/KRISP-CH01110731/2020|EPI_ISL_736926|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K004606/2020|EPI_ISL_660632|2020-11-08|Africa', 'hCoV-19/South_Africa/KRISP-K004635/2020|EPI_ISL_660651|2020-11-02|Africa', 'hCoV-19/South_Africa/KRISP-K004339/2020|EPI_ISL_660215|2020-10-28|Africa', 'hCoV-19/South_Africa/KRISP-K004609/2020|EPI_ISL_660634|2020-11-08|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c182', 'lineage': 'B.1.1.220', 'mutation': (490, 'F', 'S'), '# cluster': 12, '% lineage': 0.0, '% cluster': 0.9230769230769231, 'FC': 923076.9230769231, 'epi_start': 467, 'epi_stop': 513, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 18, '#non-linear': 35, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037749', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 14, '#pubs non-linear': 29, 'sequences': ['hCoV-19/South_Africa/KRISP-K004598/2020|EPI_ISL_660628|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004045/2020|EPI_ISL_635024|2020-10-15|Africa', 'hCoV-19/South_Africa/KRISP-K004546/2020|EPI_ISL_660243|2020-10-27|Africa', 'hCoV-19/South_Africa/KRISP-K004649/2020|EPI_ISL_660662|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K004602/2020|EPI_ISL_660631|2020-11-06|Africa', 'hCoV-19/South_Africa/KRISP-K005309/2020|EPI_ISL_678602|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004627/2020|EPI_ISL_660643|2020-11-01|Africa', 'hCoV-19/South_Africa/KRISP-CH01110731/2020|EPI_ISL_736926|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K004606/2020|EPI_ISL_660632|2020-11-08|Africa', 'hCoV-19/South_Africa/KRISP-K004635/2020|EPI_ISL_660651|2020-11-02|Africa', 'hCoV-19/South_Africa/KRISP-K004339/2020|EPI_ISL_660215|2020-10-28|Africa', 'hCoV-19/South_Africa/KRISP-K004609/2020|EPI_ISL_660634|2020-11-08|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c182', 'lineage': 'B.1.1.220', 'mutation': (834, 'I', 'V'), '# cluster': 12, '% lineage': 0.0, '% cluster': 0.9230769230769231, 'FC': 923076.9230769231, 'epi_start': 795, 'epi_stop': 874, 'epi_seq': 'KDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYT', '#linear': 30, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004598/2020|EPI_ISL_660628|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004045/2020|EPI_ISL_635024|2020-10-15|Africa', 'hCoV-19/South_Africa/KRISP-K004546/2020|EPI_ISL_660243|2020-10-27|Africa', 'hCoV-19/South_Africa/KRISP-K004649/2020|EPI_ISL_660662|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K004602/2020|EPI_ISL_660631|2020-11-06|Africa', 'hCoV-19/South_Africa/KRISP-K005309/2020|EPI_ISL_678602|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004627/2020|EPI_ISL_660643|2020-11-01|Africa', 'hCoV-19/South_Africa/KRISP-CH01110731/2020|EPI_ISL_736926|2020-11-26|Africa', 'hCoV-19/South_Africa/KRISP-K004606/2020|EPI_ISL_660632|2020-11-08|Africa', 'hCoV-19/South_Africa/KRISP-K004635/2020|EPI_ISL_660651|2020-11-02|Africa', 'hCoV-19/South_Africa/KRISP-K004339/2020|EPI_ISL_660215|2020-10-28|Africa', 'hCoV-19/South_Africa/KRISP-K004609/2020|EPI_ISL_660634|2020-11-08|Africa'], 'annotations': []}, {'cluster': 'c199', 'lineage': 'B.1.1.84', 'mutation': (614, 'D', 'G'), '# cluster': 11, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-0365/2020|EPI_ISL_487316|2020-06-25|Africa', 'hCoV-19/South_Africa/KRISP-0378/2020|EPI_ISL_487327|2020-06-22|Africa', 'hCoV-19/South_Africa/KRISP-K002712/2020|EPI_ISL_535571|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K003671/2020|EPI_ISL_602627|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-0291/2020|EPI_ISL_487281|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-K002186/2020|EPI_ISL_515585|2020-06-30|Africa', 'hCoV-19/South_Africa/KRISP-K003673/2020|EPI_ISL_602629|2020-07-06|Africa', 'hCoV-19/South_Africa/KRISP-0369/2020|EPI_ISL_487320|2020-06-25|Africa', 'hCoV-19/South_Africa/KRISP-0290/2020|EPI_ISL_487280|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-0287/2020|EPI_ISL_487278|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-0380/2020|EPI_ISL_487328|2020-06-25|Africa'], 'annotations': []}, {'cluster': 'c199', 'lineage': 'B.1.1.84', 'mutation': (653, 'A', 'V'), '# cluster': 11, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 634, 'epi_stop': 689, 'epi_seq': 'RVYSTGSNVFQTRAGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVAS', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0365/2020|EPI_ISL_487316|2020-06-25|Africa', 'hCoV-19/South_Africa/KRISP-0378/2020|EPI_ISL_487327|2020-06-22|Africa', 'hCoV-19/South_Africa/KRISP-K002712/2020|EPI_ISL_535571|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K003671/2020|EPI_ISL_602627|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-0291/2020|EPI_ISL_487281|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-K002186/2020|EPI_ISL_515585|2020-06-30|Africa', 'hCoV-19/South_Africa/KRISP-K003673/2020|EPI_ISL_602629|2020-07-06|Africa', 'hCoV-19/South_Africa/KRISP-0369/2020|EPI_ISL_487320|2020-06-25|Africa', 'hCoV-19/South_Africa/KRISP-0290/2020|EPI_ISL_487280|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-0287/2020|EPI_ISL_487278|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-0380/2020|EPI_ISL_487328|2020-06-25|Africa'], 'annotations': []}, {'cluster': 'c203', 'lineage': 'B.1.1.34', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002739/2020|EPI_ISL_529737|2020-08-13|Africa', 'hCoV-19/South_Africa/KRISP-K003696/2020|EPI_ISL_602876|2020-10-05|Africa', 'hCoV-19/South_Africa/KRISP-K001326/2020|EPI_ISL_515811|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K002735/2020|EPI_ISL_529733|2020-08-16|Africa', 'hCoV-19/South_Africa/KRISP-K002732/2020|EPI_ISL_529730|2020-08-15|Africa'], 'annotations': []}, {'cluster': 'c203', 'lineage': 'B.1.1.34', 'mutation': (810, 'S', 'L'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 779, 'epi_stop': 837, 'epi_seq': 'QEVFAQVKQIYKTPPIKDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQY', '#linear': 35, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 14, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002739/2020|EPI_ISL_529737|2020-08-13|Africa', 'hCoV-19/South_Africa/KRISP-K003696/2020|EPI_ISL_602876|2020-10-05|Africa', 'hCoV-19/South_Africa/KRISP-K001326/2020|EPI_ISL_515811|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K002735/2020|EPI_ISL_529733|2020-08-16|Africa', 'hCoV-19/South_Africa/KRISP-K002732/2020|EPI_ISL_529730|2020-08-15|Africa'], 'annotations': []}, {'cluster': 'c204', 'lineage': 'B.1.1.34', 'mutation': (614, 'D', 'G'), '# cluster': 6, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002243/2020|EPI_ISL_515634|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K000641/2020|EPI_ISL_509290|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002350/2020|EPI_ISL_515722|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K002351/2020|EPI_ISL_515723|2020-07-21|Africa', 'hCoV-19/South_Africa/L00170/2020|EPI_ISL_622943|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K003724/2020|EPI_ISL_602902|2020-10-06|Africa'], 'annotations': []}, {'cluster': 'c204', 'lineage': 'B.1.1.34', 'mutation': (1162, 'P', 'S'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.16666666666666666, 'FC': 166666.66666666666, 'epi_start': 1135, 'epi_stop': 1184, 'epi_seq': 'NTVYDPLQPELDSFKEELDKYFKNHTSPDVDLGDISGINASVVNIQKEID', '#linear': 13, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002243/2020|EPI_ISL_515634|2020-07-21|Africa'], 'annotations': []}, {'cluster': 'c204', 'lineage': 'B.1.1.34', 'mutation': (1244, 'L', 'F'), '# cluster': 6, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 1202, 'epi_stop': 1258, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLKGCCSCGSCCKFDE', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002243/2020|EPI_ISL_515634|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K000641/2020|EPI_ISL_509290|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002350/2020|EPI_ISL_515722|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K002351/2020|EPI_ISL_515723|2020-07-21|Africa', 'hCoV-19/South_Africa/L00170/2020|EPI_ISL_622943|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K003724/2020|EPI_ISL_602902|2020-10-06|Africa'], 'annotations': ['cytoplasm domain']}, {'cluster': 'c204', 'lineage': 'B.1.1.34', 'mutation': (121, 'N', 'T'), '# cluster': 3, '% lineage': 0.0, '% cluster': 0.5, 'FC': 500000.0, 'epi_start': 92, 'epi_stop': 138, 'epi_seq': 'FASTEKSNIIRGWIFGTTLDSKTQSLLIVNNATNVVIKVCEFQFCND', '#linear': 10, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 5, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K000641/2020|EPI_ISL_509290|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002350/2020|EPI_ISL_515722|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K002351/2020|EPI_ISL_515723|2020-07-21|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c208', 'lineage': 'B.1.1.62', 'mutation': (614, 'D', 'G'), '# cluster': 19, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K001388/2020|EPI_ISL_515872|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K002466/2020|EPI_ISL_518049|2020-06-23|Africa', 'hCoV-19/South_Africa/KRISP-K001317/2020|EPI_ISL_515802|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K002370/2020|EPI_ISL_515738|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002632/2020|EPI_ISL_535502|2020-07-31|Africa', 'hCoV-19/South_Africa/KRISP-K002399/2020|EPI_ISL_515763|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K000567/2020|EPI_ISL_509224|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-0417/2020|EPI_ISL_495541|2020-07-02|Africa', 'hCoV-19/South_Africa/KRISP-K002437/2020|EPI_ISL_515794|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K001055/2020|EPI_ISL_509313|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002595/2020|EPI_ISL_535460|2020-07-29|Africa', 'hCoV-19/South_Africa/KRISP-K002265/2020|EPI_ISL_515648|2020-07-20|Africa', 'hCoV-19/South_Africa/KRISP-K002594/2020|EPI_ISL_535459|2020-07-28|Africa', 'hCoV-19/South_Africa/KRISP-K001332/2020|EPI_ISL_515817|2020-07-19|Africa', 'hCoV-19/South_Africa/R13472-20/2020|EPI_ISL_622914|2020-07-06|Africa', 'hCoV-19/South_Africa/KRISP-K002190/2020|EPI_ISL_515589|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-K001099/2020|EPI_ISL_509348|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-0386/2020|EPI_ISL_487329|2020-07-01|Africa', 'hCoV-19/South_Africa/KRISP-K001336/2020|EPI_ISL_515821|2020-07-19|Africa'], 'annotations': []}, {'cluster': 'c208', 'lineage': 'B.1.1.62', 'mutation': (845, 'A', 'S'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.05263157894736842, 'FC': 52631.57894736842, 'epi_start': 826, 'epi_stop': 874, 'epi_seq': 'VTLADAGFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYT', '#linear': 19, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002594/2020|EPI_ISL_535459|2020-07-28|Africa'], 'annotations': []}, {'cluster': 'c210', 'lineage': 'B.1.1.314', 'mutation': (614, 'D', 'G'), '# cluster': 2, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Chile/RM-133091/2020|EPI_ISL_746629|2020-07-24|SouthAmerica', 'hCoV-19/Chile/RM-110750/2020|EPI_ISL_746565|2020-06-25|SouthAmerica'], 'annotations': []}, {'cluster': 'c210', 'lineage': 'B.1.1.33', 'mutation': (583, 'E', 'D'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.3333333333333333, 'FC': 333333.3333333333, 'epi_start': 564, 'epi_stop': 595, 'epi_seq': 'QFGRDIADTTDAVRDPQTLEILDITPCSFGGV', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037971', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Brazil/RS-6189/2020|EPI_ISL_729825|2020-05-10|SouthAmerica'], 'annotations': []}, {'cluster': 'c210', 'lineage': 'B.1.1.33', 'mutation': (614, 'D', 'G'), '# cluster': 3, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Brazil/RS-6189/2020|EPI_ISL_729825|2020-05-10|SouthAmerica', 'hCoV-19/Brazil/AP-IEC165669/2020|EPI_ISL_524793|2020-04-29|SouthAmerica', 'hCoV-19/Brazil/RJ-00439/2020|EPI_ISL_717834|2020-06-02|SouthAmerica'], 'annotations': []}, {'cluster': 'c211', 'lineage': 'B.1.1.216', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-3462/2020|EPI_ISL_640132|2020-09-28|Africa'], 'annotations': []}, {'cluster': 'c211', 'lineage': 'B.1.1.216', 'mutation': (846, 'A', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 828, 'epi_stop': 874, 'epi_seq': 'LADAGFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYT', '#linear': 15, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-3462/2020|EPI_ISL_640132|2020-09-28|Africa'], 'annotations': []}, {'cluster': 'c211', 'lineage': 'B.1.1.4', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002427/2020|EPI_ISL_515788|2020-07-30|Africa'], 'annotations': []}, {'cluster': 'c211', 'lineage': 'B.1.1.75', 'mutation': (614, 'D', 'G'), '# cluster': 19, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-0278/2020|EPI_ISL_482865|2020-06-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5818/2020|EPI_ISL_700473|2020-05-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5720/2020|EPI_ISL_700568|2020-05-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5256/2020|EPI_ISL_700471|2020-04-30|Africa', 'hCoV-19/South_Africa/R13531-20/2020|EPI_ISL_622901|2020-07-09|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2683/2020|EPI_ISL_700415|2020-05-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5244/2020|EPI_ISL_700544|2020-04-29|Africa', 'hCoV-19/South_Africa/R06812/2020|EPI_ISL_490256|2020-04-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5912/2020|EPI_ISL_700477|2020-05-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5016/2020|EPI_ISL_640096|2020-04-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5031/2020|EPI_ISL_640098|2020-04-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3086/2020|EPI_ISL_700418|2020-05-03|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5002/2020|EPI_ISL_700413|2020-04-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0086/2020|EPI_ISL_640059|2020-04-04|Africa', 'hCoV-19/South_Africa/KRISP-0150/2020|EPI_ISL_467500|2020-05-30|Africa', 'hCoV-19/Zimbabwe/ZW-9102/2020|EPI_ISL_644760|2020-06-01|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5227/2020|EPI_ISL_640104|2020-04-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5020/2020|EPI_ISL_700527|2020-04-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5888/2020|EPI_ISL_700573|2020-05-24|Africa'], 'annotations': []}, {'cluster': 'c211', 'lineage': 'B.1.1.75', 'mutation': (846, 'A', 'V'), '# cluster': 18, '% lineage': 1.0, '% cluster': 0.9473684210526315, 'FC': 0.947367473685158, 'epi_start': 828, 'epi_stop': 874, 'epi_seq': 'LADAGFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYT', '#linear': 15, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0278/2020|EPI_ISL_482865|2020-06-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5818/2020|EPI_ISL_700473|2020-05-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5720/2020|EPI_ISL_700568|2020-05-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5256/2020|EPI_ISL_700471|2020-04-30|Africa', 'hCoV-19/South_Africa/R13531-20/2020|EPI_ISL_622901|2020-07-09|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2683/2020|EPI_ISL_700415|2020-05-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5244/2020|EPI_ISL_700544|2020-04-29|Africa', 'hCoV-19/South_Africa/R06812/2020|EPI_ISL_490256|2020-04-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5912/2020|EPI_ISL_700477|2020-05-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5016/2020|EPI_ISL_640096|2020-04-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5031/2020|EPI_ISL_640098|2020-04-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3086/2020|EPI_ISL_700418|2020-05-03|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5002/2020|EPI_ISL_700413|2020-04-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0086/2020|EPI_ISL_640059|2020-04-04|Africa', 'hCoV-19/South_Africa/KRISP-0150/2020|EPI_ISL_467500|2020-05-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5227/2020|EPI_ISL_640104|2020-04-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5020/2020|EPI_ISL_700527|2020-04-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5888/2020|EPI_ISL_700573|2020-05-24|Africa'], 'annotations': []}, {'cluster': 'c211', 'lineage': 'B.1.1.75', 'mutation': (846, 'A', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.05263157894736842, 'FC': 52631.57894736842, 'epi_start': 828, 'epi_stop': 874, 'epi_seq': 'LADAGFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYT', '#linear': 15, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Zimbabwe/ZW-9102/2020|EPI_ISL_644760|2020-06-01|Africa'], 'annotations': []}, {'cluster': 'c217', 'lineage': 'B.1.1.109', 'mutation': (477, 'S', 'N'), '# cluster': 8, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 458, 'epi_stop': 513, 'epi_seq': 'KSNLKPFERDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 35, '#non-linear': 28, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038157'], '#pubs linear': 10, '#pubs non-linear': 17, 'sequences': ['hCoV-19/South_Africa/KRISP-K004532-CS1/2020|EPI_ISL_660230|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-BH02956621/2020|EPI_ISL_736984|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K004531-CS1/2020|EPI_ISL_660229|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004347-CS1/2020|EPI_ISL_660221|2020-11-09|Africa', 'hCoV-19/South_Africa/KRISP-K004530-CS1/2020|EPI_ISL_660228|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004725-CS1/2020|EPI_ISL_660258|2020-11-18|Africa', 'hCoV-19/South_Africa/KRISP-K004533-CS1/2020|EPI_ISL_660231|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004724-CS1/2020|EPI_ISL_660257|2020-11-18|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c217', 'lineage': 'B.1.1.109', 'mutation': (614, 'D', 'G'), '# cluster': 8, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004532-CS1/2020|EPI_ISL_660230|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-BH02956621/2020|EPI_ISL_736984|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K004531-CS1/2020|EPI_ISL_660229|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004347-CS1/2020|EPI_ISL_660221|2020-11-09|Africa', 'hCoV-19/South_Africa/KRISP-K004530-CS1/2020|EPI_ISL_660228|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004725-CS1/2020|EPI_ISL_660258|2020-11-18|Africa', 'hCoV-19/South_Africa/KRISP-K004533-CS1/2020|EPI_ISL_660231|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004724-CS1/2020|EPI_ISL_660257|2020-11-18|Africa'], 'annotations': []}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (69, 'H', '-'), '# cluster': 7, '% lineage': 0.9945132327103192, '% cluster': 1.0, 'FC': 1.0055160269297811, 'epi_start': 54, 'epi_stop': 85, 'epi_seq': 'LFLPFFSNVTWFHAIHVSGTNGTKRFDNPVLP', '#linear': 12, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065'], '#pubs linear': 6, '#pubs non-linear': 1, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (70, 'V', '-'), '# cluster': 7, '% lineage': 0.9943942559107951, '% cluster': 1.0, 'FC': 1.0056363343005608, 'epi_start': 54, 'epi_stop': 85, 'epi_seq': 'LFLPFFSNVTWFHAIHVSGTNGTKRFDNPVLP', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (144, 'Y', '-'), '# cluster': 6, '% lineage': 0.9853188163191898, '% cluster': 0.8571428571428571, 'FC': 0.8699133448313695, 'epi_start': 122, 'epi_stop': 171, 'epi_seq': 'NATNVVIKVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYV', '#linear': 35, '#non-linear': 21, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1037008', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038080', 'http://www.iedb.org/reference/1038547', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038474'], '#pubs linear': 12, '#pubs non-linear': 9, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (501, 'N', 'Y'), '# cluster': 7, '% lineage': 0.988857684379453, '% cluster': 1.0, 'FC': 1.011266843075296, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (570, 'A', 'D'), '# cluster': 7, '% lineage': 0.9982402501279692, '% cluster': 1.0, 'FC': 1.001761848522895, 'epi_start': 547, 'epi_stop': 586, 'epi_seq': 'TGTGVLTESNKKFLPFQQFGRDIADTTDAVRDPQTLEILD', '#linear': 27, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': []}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.9987742622746704, '% cluster': 1.0, 'FC': 1.0012262395471634, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': []}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (681, 'P', 'H'), '# cluster': 7, '% lineage': 0.9977422077113568, '% cluster': 1.0, 'FC': 1.0022618969201704, 'epi_start': 647, 'epi_stop': 698, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAYTMS', '#linear': 42, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 12, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': []}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (716, 'T', 'I'), '# cluster': 7, '% lineage': 0.9871975429907447, '% cluster': 1.0, 'FC': 1.0129674593830669, 'epi_start': 684, 'epi_stop': 735, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEILPVSMTKTS', '#linear': 16, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038085'], '#pubs linear': 8, '#pubs non-linear': 1, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': []}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (982, 'S', 'A'), '# cluster': 7, '% lineage': 0.9873386550087849, '% cluster': 1.0, 'FC': 1.0128226846019899, 'epi_start': 960, 'epi_stop': 1022, 'epi_seq': 'NTLVKQLSSNFGAISSVLNDILSRLDKVEAEVQIDRLITGRLQSLQTYVTQQLIRAAEIRASA', '#linear': 18, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1037942', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037363', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037968', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 17, '#pubs non-linear': 2, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': ['heptapeptide repeat sequence 1']}, {'cluster': 'c221', 'lineage': 'B.1.1.7', 'mutation': (1118, 'D', 'H'), '# cluster': 7, '% lineage': 0.9982208818117676, '% cluster': 1.0, 'FC': 1.0017812855244217, 'epi_start': 1105, 'epi_stop': 1131, 'epi_seq': 'TQRNFYEPQIITTDNTFVSGNCDVVIG', '#linear': 17, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/CAMC-B7A604/2020|EPI_ISL_741129|2020-11-12|Europe', 'hCoV-19/England/MILK-B3B739/2020|EPI_ISL_679764|2020-11-01|Europe', 'hCoV-19/South_Africa/Tygerberg_531/2021|EPI_ISL_912401|2021-01-09|Africa', 'hCoV-19/England/CAMC-F99B84/2021|EPI_ISL_851121|2021-01-10|Europe', 'hCoV-19/Belgium/rega-1793/2021|EPI_ISL_894185|2021-01-05|Europe', 'hCoV-19/England/CAMC-A660B3/2020|EPI_ISL_637676|2020-10-11|Europe', 'hCoV-19/England/CAMC-B32635/2020|EPI_ISL_659294|2020-11-05|Europe'], 'annotations': []}, {'cluster': 'c224', 'lineage': 'H.1', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002483/2020|EPI_ISL_535391|2020-08-07|Africa', 'hCoV-19/South_Africa/KRISP-K002460/2020|EPI_ISL_518044|2020-07-06|Africa', 'hCoV-19/South_Africa/KRISP-K002454/2020|EPI_ISL_518040|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002445/2020|EPI_ISL_518035|2020-07-07|Africa', 'hCoV-19/South_Africa/KRISP-K002486/2020|EPI_ISL_535393|2020-08-07|Africa'], 'annotations': []}, {'cluster': 'c225', 'lineage': 'B.1.1.67', 'mutation': (29, 'T', 'I'), '# cluster': 7, '% lineage': 0.9628647214854111, '% cluster': 1.0, 'FC': 1.03856641449163, 'epi_start': 14, 'epi_stop': 43, 'epi_seq': 'QCVNLTTRTQLPPAYTNSFTRGVYYPDKVF', '#linear': 15, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/England/ALDP-9D90DA/2020|EPI_ISL_576697|2020-09-18|Europe', 'hCoV-19/England/ALDP-9558A1/2020|EPI_ISL_554425|2020-06-12|Europe', 'hCoV-19/England/ALDP-A2E5C7/2020|EPI_ISL_586881|2020-10-05|Europe', 'hCoV-19/England/QEUH-95FC41/2020|EPI_ISL_532449|2020-08-05|Europe', 'hCoV-19/England/ALDP-A506D8/2020|EPI_ISL_597698|2020-10-07|Europe', 'hCoV-19/England/ALDP-9BDCD8/2020|EPI_ISL_568009|2020-09-09|Europe', 'hCoV-19/England/ALDP-B4802F/2020|EPI_ISL_649301|2020-11-07|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c225', 'lineage': 'B.1.1.67', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/England/ALDP-9D90DA/2020|EPI_ISL_576697|2020-09-18|Europe', 'hCoV-19/England/ALDP-9558A1/2020|EPI_ISL_554425|2020-06-12|Europe', 'hCoV-19/England/ALDP-A2E5C7/2020|EPI_ISL_586881|2020-10-05|Europe', 'hCoV-19/England/QEUH-95FC41/2020|EPI_ISL_532449|2020-08-05|Europe', 'hCoV-19/England/ALDP-A506D8/2020|EPI_ISL_597698|2020-10-07|Europe', 'hCoV-19/England/ALDP-9BDCD8/2020|EPI_ISL_568009|2020-09-09|Europe', 'hCoV-19/England/ALDP-B4802F/2020|EPI_ISL_649301|2020-11-07|Europe'], 'annotations': []}, {'cluster': 'c225', 'lineage': 'B.1.1.67', 'mutation': (1247, 'C', 'Y'), '# cluster': 1, '% lineage': 0.03183023872679045, '% cluster': 0.14285714285714285, 'FC': 4.487954241532816, 'epi_start': 1233, 'epi_stop': 1270, 'epi_seq': 'MLCCMTSCCSCLKGCCSCGSCCKFDEDDSEPVLKGVKL', '#linear': 11, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 5, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/QEUH-95FC41/2020|EPI_ISL_532449|2020-08-05|Europe'], 'annotations': ['cytoplasm domain']}, {'cluster': 'c227', 'lineage': 'B.1.1.53', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/R10007/2020|EPI_ISL_490258|2020-05-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5422/2020|EPI_ISL_700472|2020-05-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2911/2020|EPI_ISL_700578|2020-05-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5411/2020|EPI_ISL_700523|2020-05-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5482/2020|EPI_ISL_700503|2020-05-06|Africa'], 'annotations': []}, {'cluster': 'c228', 'lineage': 'B.1.1.53', 'mutation': (614, 'D', 'G'), '# cluster': 13, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/LR00111/2020|EPI_ISL_514405|2020-07-20|Africa', 'hCoV-19/South_Africa/R13509-20/2020|EPI_ISL_622916|2020-07-10|Africa', 'hCoV-19/South_Africa/R13512-20/2020|EPI_ISL_622906|2020-07-10|Africa', 'hCoV-19/South_Africa/R13562-20/2020|EPI_ISL_622912|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002548/2020|EPI_ISL_535418|2020-07-30|Africa', 'hCoV-19/South_Africa/R13502-20/2020|EPI_ISL_622921|2020-07-09|Africa', 'hCoV-19/South_Africa/R13564-20/2020|EPI_ISL_622907|2020-07-13|Africa', 'hCoV-19/South_Africa/R13563-20/2020|EPI_ISL_622908|2020-07-13|Africa', 'hCoV-19/South_Africa/R13566-20/2020|EPI_ISL_622911|2020-07-14|Africa', 'hCoV-19/South_Africa/R10741/2020|EPI_ISL_490301|2020-06-15|Africa', 'hCoV-19/South_Africa/LR00118/2020|EPI_ISL_514411|2020-07-20|Africa', 'hCoV-19/South_Africa/LR00067/2020|EPI_ISL_514379|2020-07-13|Africa', 'hCoV-19/South_Africa/LR00107/2020|EPI_ISL_514404|2020-07-14|Africa'], 'annotations': []}, {'cluster': 'c228', 'lineage': 'B.1.1.53', 'mutation': (676, 'T', 'P'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.07692307692307693, 'FC': 76923.07692307694, 'epi_start': 647, 'epi_stop': 695, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAY', '#linear': 22, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/LR00111/2020|EPI_ISL_514405|2020-07-20|Africa'], 'annotations': []}, {'cluster': 'c228', 'lineage': 'B.1.1.53', 'mutation': (1232, 'I', 'L'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.07692307692307693, 'FC': 76923.07692307694, 'epi_start': 1202, 'epi_stop': 1245, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLK', '#linear': 8, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 4, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/R13502-20/2020|EPI_ISL_622921|2020-07-09|Africa'], 'annotations': ['TM domain']}, {'cluster': 'c228', 'lineage': 'B.1.1.53', 'mutation': (255, 'S', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.07692307692307693, 'FC': 76923.07692307694, 'epi_start': 240, 'epi_stop': 282, 'epi_seq': 'TLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/R13564-20/2020|EPI_ISL_622907|2020-07-13|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c240', 'lineage': 'C.1', 'mutation': (614, 'D', 'G'), '# cluster': 25, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-3520/2020|EPI_ISL_640090|2020-10-10|Africa', 'hCoV-19/South_Africa/Tygerberg_346_CC2/2020|EPI_ISL_660150|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_339_CC2/2020|EPI_ISL_660146|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_312_CC2/2020|EPI_ISL_660121|2020-10-07|Africa', 'hCoV-19/South_Africa/Tygerberg_331_CC2/2020|EPI_ISL_660139|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_366_CC2/2020|EPI_ISL_660158|2020-10-10|Africa', 'hCoV-19/South_Africa/Tygerberg_321_CC2/2020|EPI_ISL_660130|2020-10-12|Africa', 'hCoV-19/South_Africa/Tygerberg_330_CC2/2020|EPI_ISL_660138|2020-10-08|Africa', 'hCoV-19/South_Africa/Tygerberg_329_CC2/2020|EPI_ISL_660137|2020-10-02|Africa', 'hCoV-19/South_Africa/Tygerberg_317_CC2/2020|EPI_ISL_660126|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_335_CC2/2020|EPI_ISL_660142|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_328_CC2/2020|EPI_ISL_660136|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_316_CC2/2020|EPI_ISL_660125|2020-10-07|Africa', 'hCoV-19/South_Africa/Tygerberg_314_CC2/2020|EPI_ISL_660123|2020-10-08|Africa', 'hCoV-19/South_Africa/Tygerberg_327_CC2/2020|EPI_ISL_660135|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_322_CC2/2020|EPI_ISL_660131|2020-10-12|Africa', 'hCoV-19/South_Africa/Tygerberg_326_CC2/2020|EPI_ISL_660134|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_319_CC2/2020|EPI_ISL_660128|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_338_CC2/2020|EPI_ISL_660145|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_336_CC2/2020|EPI_ISL_660143|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_315_CC2/2020|EPI_ISL_660124|2020-10-07|Africa', 'hCoV-19/South_Africa/Tygerberg_313_CC2/2020|EPI_ISL_660122|2020-10-08|Africa', 'hCoV-19/South_Africa/Tygerberg_325_CC2/2020|EPI_ISL_660133|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_334_CC2/2020|EPI_ISL_660141|2020-10-10|Africa', 'hCoV-19/South_Africa/Tygerberg_344_CC2/2020|EPI_ISL_660148|2020-10-09|Africa'], 'annotations': []}, {'cluster': 'c242', 'lineage': 'C.1', 'mutation': (614, 'D', 'G'), '# cluster': 6, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K001381/2020|EPI_ISL_515866|2020-07-19|Africa', 'hCoV-19/South_Africa/KRISP-K002431/2020|EPI_ISL_515792|2020-07-29|Africa', 'hCoV-19/South_Africa/KRISP-K002300/2020|EPI_ISL_515677|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K002291/2020|EPI_ISL_515669|2020-07-22|Africa', 'hCoV-19/South_Africa/LR00136/2020|EPI_ISL_514367|2020-07-20|Africa', 'hCoV-19/South_Africa/LR00155/2020|EPI_ISL_514423|2020-07-21|Africa'], 'annotations': []}, {'cluster': 'c255', 'lineage': 'C.9', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K001407/2020|EPI_ISL_515890|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K003739/2020|EPI_ISL_602916|2020-09-29|Africa', 'hCoV-19/South_Africa/KRISP-K002897/2020|EPI_ISL_602709|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K001391/2020|EPI_ISL_515875|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K001397/2020|EPI_ISL_515880|2020-07-18|Africa'], 'annotations': []}, {'cluster': 'c257', 'lineage': 'C.9', 'mutation': (614, 'D', 'G'), '# cluster': 6, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002352/2020|EPI_ISL_515724|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K002629/2020|EPI_ISL_535499|2020-07-31|Africa', 'hCoV-19/South_Africa/KRISP-K002311/2020|EPI_ISL_515687|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K003690/2020|EPI_ISL_602872|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K003740/2020|EPI_ISL_602917|2020-09-29|Africa', 'hCoV-19/South_Africa/KRISP-K003753/2020|EPI_ISL_602926|2020-09-30|Africa'], 'annotations': []}, {'cluster': 'c257', 'lineage': 'C.9', 'mutation': (1084, 'D', 'Y'), '# cluster': 6, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 1054, 'epi_stop': 1098, 'epi_seq': 'QSAPHGVVFLHVTYVPAQEKNFTTAPAICHDGKAHFPREGVFVSN', '#linear': 25, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002352/2020|EPI_ISL_515724|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K002629/2020|EPI_ISL_535499|2020-07-31|Africa', 'hCoV-19/South_Africa/KRISP-K002311/2020|EPI_ISL_515687|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K003690/2020|EPI_ISL_602872|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K003740/2020|EPI_ISL_602917|2020-09-29|Africa', 'hCoV-19/South_Africa/KRISP-K003753/2020|EPI_ISL_602926|2020-09-30|Africa'], 'annotations': []}, {'cluster': 'c259', 'lineage': 'B.1.1.1', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 0.9995777027027027, '% cluster': 1.0, 'FC': 1.000421474863518, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/L00193/2020|EPI_ISL_622956|2020-00-00|Africa'], 'annotations': []}, {'cluster': 'c259', 'lineage': 'C.2', 'mutation': (614, 'D', 'G'), '# cluster': 12, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/LR00078/2020|EPI_ISL_514389|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-0390/2020|EPI_ISL_487333|2020-07-01|Africa', 'hCoV-19/South_Africa/KRISP-K002693/2020|EPI_ISL_535555|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K005318/2020|EPI_ISL_678610|2020-11-15|Africa', 'hCoV-19/South_Africa/KRISP-0395/2020|EPI_ISL_487338|2020-07-01|Africa', 'hCoV-19/South_Africa/KRISP-K001045/2020|EPI_ISL_509307|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K003687/2020|EPI_ISL_602869|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-0543/2020|EPI_ISL_498084|2020-07-12|Africa', 'hCoV-19/South_Africa/KRISP-0565/2020|EPI_ISL_498104|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-K002282/2020|EPI_ISL_515662|2020-07-21|Africa', 'hCoV-19/South_Africa/R10517/2020|EPI_ISL_490282|2020-06-09|Africa', 'hCoV-19/South_Africa/LR00037/2020|EPI_ISL_515164|2020-07-05|Africa'], 'annotations': []}, {'cluster': 'c259', 'lineage': 'C.2', 'mutation': (384, 'P', 'S'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.08333333333333333, 'FC': 83333.33333333333, 'epi_start': 351, 'epi_stop': 403, 'epi_seq': 'YAWNRKRISNCVADYSVLYNSASFSTFKCYGVSPTKLNDLCFTNVYADSFVIR', '#linear': 30, '#non-linear': 19, 'pubs linear': ['http://www.iedb.org/reference/1037576', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1036858', 'http://www.iedb.org/reference/1037157', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038067', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1037006', 'http://www.iedb.org/reference/1038093', 'http://www.iedb.org/reference/1038244', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1037523', 'http://www.iedb.org/reference/1037109', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1036587', 'http://www.iedb.org/reference/1038415'], '#pubs linear': 12, '#pubs non-linear': 18, 'sequences': ['hCoV-19/South_Africa/KRISP-0390/2020|EPI_ISL_487333|2020-07-01|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c259', 'lineage': 'C.2', 'mutation': (222, 'A', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.08333333333333333, 'FC': 83333.33333333333, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0543/2020|EPI_ISL_498084|2020-07-12|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c260', 'lineage': 'B.1.1.1', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.9995777027027027, '% cluster': 1.0, 'FC': 1.000421474863518, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Italy/VEN-IZSVe-20RS2155-12_VI/2020|EPI_ISL_794827|2020-11-06|Europe', 'hCoV-19/France/ARA-113487/2020|EPI_ISL_745345|2020-11-28|Europe', 'hCoV-19/Italy/CAM-TIGEM-168/2020|EPI_ISL_736886|2020-10-26|Europe', 'hCoV-19/Italy/CAM-TIGEM-197/2020|EPI_ISL_776910|2020-10-26|Europe', 'hCoV-19/Italy/CAM-TIGEM-330/2020|EPI_ISL_776975|2020-09-03|Europe'], 'annotations': []}, {'cluster': 'c260', 'lineage': 'B.1.1.1', 'mutation': (572, 'T', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.2, 'FC': 200000.00000000003, 'epi_start': 554, 'epi_stop': 586, 'epi_seq': 'ESNKKFLPFQQFGRDIADTTDAVRDPQTLEILD', '#linear': 15, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/France/ARA-113487/2020|EPI_ISL_745345|2020-11-28|Europe'], 'annotations': []}, {'cluster': 'c260', 'lineage': 'B.1.1.1', 'mutation': (308, 'V', 'L'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.2, 'FC': 200000.00000000003, 'epi_start': 294, 'epi_stop': 323, 'epi_seq': 'DPLSETKCTLKSFTVEKGIYQTSNFRVQPT', '#linear': 25, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/Italy/CAM-TIGEM-168/2020|EPI_ISL_736886|2020-10-26|Europe'], 'annotations': []}, {'cluster': 'c263', 'lineage': 'B.1.1.1', 'mutation': (614, 'D', 'G'), '# cluster': 15, '% lineage': 0.9995777027027027, '% cluster': 1.0, 'FC': 1.000421474863518, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Switzerland/BL-ETHZ-190034/2020|EPI_ISL_500897|2020-07-08|Europe', 'hCoV-19/Switzerland/BE-ETHZ-210076/2020|EPI_ISL_511992|2020-07-22|Europe', 'hCoV-19/Switzerland/BS-ETHZ-190088/2020|EPI_ISL_500944|2020-07-07|Europe', 'hCoV-19/Serbia/C16875/2020|EPI_ISL_891269|2020-07-30|Europe', 'hCoV-19/Italy/FVG-ICGEB-S218/2020|EPI_ISL_498563|2020-07-06|Europe', 'hCoV-19/Italy/ABR-IZSGC-TE101729/2020|EPI_ISL_849662|2020-07-24|Europe', 'hCoV-19/Germany/HE-Cento-36971058/2020|EPI_ISL_815261|2020-07-13|Europe', 'hCoV-19/Germany/HE-Cento-30781659/2020|EPI_ISL_815281|2020-07-11|Europe', 'hCoV-19/Wales/QEUH-99630D/2020|EPI_ISL_560305|2020-08-28|Europe', 'hCoV-19/Germany/BE-ChVir-D1928-7459/2020|EPI_ISL_753872|2020-10-09|Europe', 'hCoV-19/Scotland/QEUH-99BE07/2020|EPI_ISL_559999|2020-08-30|Europe', 'hCoV-19/England/MILK-970846/2020|EPI_ISL_553048|2020-08-17|Europe', 'hCoV-19/England/CAMC-9B1E92/2020|EPI_ISL_549398|2020-09-04|Europe', 'hCoV-19/England/QEUH-996349/2020|EPI_ISL_549525|2020-08-27|Europe', 'hCoV-19/England/QEUH-996895/2020|EPI_ISL_549537|2020-08-29|Europe'], 'annotations': []}, {'cluster': 'c269', 'lineage': 'B.1.1.1', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.9995777027027027, '% cluster': 1.0, 'FC': 1.000421474863518, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Korea/KCDC2674/2020|EPI_ISL_522456|2020-06-18|Asia', 'hCoV-19/South_Korea/KDCA0492/2020|EPI_ISL_850203|2020-06-11|Asia', 'hCoV-19/Spain/PV-IBV-005154/2020|EPI_ISL_509642|2020-06-22|Europe', 'hCoV-19/Spain/PV-IBV-005161/2020|EPI_ISL_509647|2020-06-23|Europe', 'hCoV-19/England/ALDP-4ABC69/2020|EPI_ISL_559460|2020-06-12|Europe'], 'annotations': []}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (18, 'L', 'F'), '# cluster': 4, '% lineage': 0.37103594080338265, '% cluster': 0.8, 'FC': 2.156119545045329, 'epi_start': 1, 'epi_stop': 34, 'epi_seq': 'MFVFLVLLPLVSSQCVNLTTRTQLPPAYTNSFTR', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 4, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 5, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 5, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 5, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 5, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 5, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 5, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': []}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 5, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007793/2021|EPI_ISL_860567|2021-01-02|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-75/2020|EPI_ISL_912493|2020-12-03|Africa', 'hCoV-19/South_Africa/KRISP-K007783/2021|EPI_ISL_860558|2021-01-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920866/2020|EPI_ISL_736966|2020-12-06|Africa', 'hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': []}, {'cluster': 'c28', 'lineage': 'B.1.351', 'mutation': (108, 'T', 'N'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.2, 'FC': 200000.00000000003, 'epi_start': 92, 'epi_stop': 134, 'epi_seq': 'FASTEKSNIIRGWIFGTTLDSKTQSLLIVNNATNVVIKVCEFQ', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-MDSH920888/2020|EPI_ISL_736968|2020-12-06|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c282', 'lineage': 'B.1.1.57', 'mutation': (614, 'D', 'G'), '# cluster': 16, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002541/2020|EPI_ISL_535411|2020-07-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0620/2020|EPI_ISL_700564|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005356/2020|EPI_ISL_678637|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-0274/2020|EPI_ISL_482861|2020-06-18|Africa', 'hCoV-19/South_Africa/KRISP-0273/2020|EPI_ISL_482860|2020-06-18|Africa', 'hCoV-19/South_Africa/KRISP-0276/2020|EPI_ISL_482863|2020-06-18|Africa', 'hCoV-19/South_Africa/KRISP-K003340/2020|EPI_ISL_602732|2020-09-07|Africa', 'hCoV-19/South_Africa/KRISP-K003679/2020|EPI_ISL_602865|2020-09-20|Africa', 'hCoV-19/South_Africa/KRISP-K003698/2020|EPI_ISL_602878|2020-10-04|Africa', 'hCoV-19/South_Africa/KRISP-K004081/2020|EPI_ISL_635057|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004038/2020|EPI_ISL_635019|2020-10-15|Africa', 'hCoV-19/South_Africa/KRISP-K003359/2020|EPI_ISL_602750|2020-09-03|Africa', 'hCoV-19/South_Africa/KRISP-K004054/2020|EPI_ISL_635033|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K003398/2020|EPI_ISL_602786|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K003721/2020|EPI_ISL_605788|2020-10-07|Africa', 'hCoV-19/South_Africa/KRISP-K003742/2020|EPI_ISL_602918|2020-09-29|Africa'], 'annotations': []}, {'cluster': 'c282', 'lineage': 'B.1.1.57', 'mutation': (1260, 'D', 'Y'), '# cluster': 16, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 1246, 'epi_stop': 1273, 'epi_seq': 'GCCSCGSCCKFDEDDSEPVLKGVKLHYT', '#linear': 16, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002541/2020|EPI_ISL_535411|2020-07-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0620/2020|EPI_ISL_700564|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005356/2020|EPI_ISL_678637|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-0274/2020|EPI_ISL_482861|2020-06-18|Africa', 'hCoV-19/South_Africa/KRISP-0273/2020|EPI_ISL_482860|2020-06-18|Africa', 'hCoV-19/South_Africa/KRISP-0276/2020|EPI_ISL_482863|2020-06-18|Africa', 'hCoV-19/South_Africa/KRISP-K003340/2020|EPI_ISL_602732|2020-09-07|Africa', 'hCoV-19/South_Africa/KRISP-K003679/2020|EPI_ISL_602865|2020-09-20|Africa', 'hCoV-19/South_Africa/KRISP-K003698/2020|EPI_ISL_602878|2020-10-04|Africa', 'hCoV-19/South_Africa/KRISP-K004081/2020|EPI_ISL_635057|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004038/2020|EPI_ISL_635019|2020-10-15|Africa', 'hCoV-19/South_Africa/KRISP-K003359/2020|EPI_ISL_602750|2020-09-03|Africa', 'hCoV-19/South_Africa/KRISP-K004054/2020|EPI_ISL_635033|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K003398/2020|EPI_ISL_602786|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K003721/2020|EPI_ISL_605788|2020-10-07|Africa', 'hCoV-19/South_Africa/KRISP-K003742/2020|EPI_ISL_602918|2020-09-29|Africa'], 'annotations': ['cytoplasm domain']}, {'cluster': 'c282', 'lineage': 'B.1.1.57', 'mutation': (152, 'W', 'L'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.125, 'FC': 125000.0, 'epi_start': 129, 'epi_stop': 171, 'epi_seq': 'KVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYV', '#linear': 16, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1037008', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 10, '#pubs non-linear': 5, 'sequences': ['hCoV-19/South_Africa/KRISP-K004081/2020|EPI_ISL_635057|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004038/2020|EPI_ISL_635019|2020-10-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c285', 'lineage': 'B.1.1.57', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002444/2020|EPI_ISL_518034|2020-07-07|Africa', 'hCoV-19/South_Africa/KRISP-K002175/2020|EPI_ISL_515577|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-K002177/2020|EPI_ISL_515579|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-K002449/2020|EPI_ISL_518038|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-0296/2020|EPI_ISL_487284|2020-06-26|Africa', 'hCoV-19/South_Africa/KRISP-K002555/2020|EPI_ISL_535424|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K002424/2020|EPI_ISL_515785|2020-07-30|Africa'], 'annotations': []}, {'cluster': 'c289', 'lineage': 'B.1.1.311', 'mutation': (614, 'D', 'G'), '# cluster': 8, '% lineage': 0.9997669540899558, '% cluster': 1.0, 'FC': 1.000232099767846, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/England/QEUH-9CA29A/2020|EPI_ISL_567312|2020-09-10|Europe', 'hCoV-19/England/ALDP-9B5E07/2020|EPI_ISL_572968|2020-08-29|Europe', 'hCoV-19/Wales/PHWC-485139/2020|EPI_ISL_628150|2020-10-21|Europe', 'hCoV-19/England/ALDP-B766DB/2020|EPI_ISL_723772|2020-11-12|Europe', 'hCoV-19/Wales/PHWC-47E6BC/2020|EPI_ISL_595487|2020-10-10|Europe', 'hCoV-19/England/QEUH-B7D003/2020|EPI_ISL_741839|2020-11-14|Europe', 'hCoV-19/England/CAMC-9DFFC8/2020|EPI_ISL_576949|2020-09-21|Europe', 'hCoV-19/England/MILK-B3B0C5/2020|EPI_ISL_679741|2020-11-01|Europe'], 'annotations': []}, {'cluster': 'c289', 'lineage': 'B.1.1.311', 'mutation': (477, 'S', 'I'), '# cluster': 1, '% lineage': 0.0515031461197856, '% cluster': 0.125, 'FC': 2.426989075972285, 'epi_start': 458, 'epi_stop': 513, 'epi_seq': 'KSNLKPFERDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 35, '#non-linear': 28, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038157'], '#pubs linear': 10, '#pubs non-linear': 17, 'sequences': ['hCoV-19/Wales/PHWC-485139/2020|EPI_ISL_628150|2020-10-21|Europe'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c289', 'lineage': 'B.1.1.311', 'mutation': (957, 'Q', 'L'), '# cluster': 1, '% lineage': 0.008622698671638312, '% cluster': 0.125, 'FC': 14.494940600267144, 'epi_start': 939, 'epi_stop': 971, 'epi_seq': 'SSTASALGKLQDVVNQNAQALNTLVKQLSSNFG', '#linear': 27, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/ALDP-B766DB/2020|EPI_ISL_723772|2020-11-12|Europe'], 'annotations': ['heptapeptide repeat sequence 1']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 9, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 9, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 9, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 9, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 9, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 9, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 9, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 9, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 9, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': []}, {'cluster': 'c29', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 9, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1653-KRISP/2020|EPI_ISL_696485|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7020-KRISP/2020|EPI_ISL_696483|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7066-KRISP/2020|EPI_ISL_696506|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7055-KRISP/2020|EPI_ISL_696516|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352301/2020|EPI_ISL_736981|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7015-KRISP/2020|EPI_ISL_696457|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7060-KRISP/2020|EPI_ISL_696514|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7049-KRISP/2020|EPI_ISL_696518|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7052-KRISP/2020|EPI_ISL_696517|2020-11-24|Africa'], 'annotations': []}, {'cluster': 'c290', 'lineage': 'B.1.1.309', 'mutation': (614, 'D', 'G'), '# cluster': 6, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/England/QEUH-9C9ADF/2020|EPI_ISL_567509|2020-09-10|Europe', 'hCoV-19/England/CAMC-A42062/2020|EPI_ISL_609318|2020-10-05|Europe', 'hCoV-19/England/QEUH-9B0F45/2020|EPI_ISL_559869|2020-09-03|Europe', 'hCoV-19/England/QEUH-9AE0DE/2020|EPI_ISL_638625|2020-09-05|Europe', 'hCoV-19/England/QEUH-B2D4D9/2020|EPI_ISL_660026|2020-11-04|Europe', 'hCoV-19/England/QEUH-B678E6/2020|EPI_ISL_655920|2020-11-07|Europe'], 'annotations': []}, {'cluster': 'c290', 'lineage': 'B.1.1.309', 'mutation': (198, 'D', 'G'), '# cluster': 1, '% lineage': 0.05737704918032787, '% cluster': 0.16666666666666666, 'FC': 2.904711279793885, 'epi_start': 184, 'epi_stop': 215, 'epi_seq': 'GNFKNLREFVFKNIDGYFKIYSKHTPINLVRD', '#linear': 41, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037971', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/QEUH-B678E6/2020|EPI_ISL_655920|2020-11-07|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c291', 'lineage': 'B.1.1.119', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-0266/2020|EPI_ISL_482853|2020-06-17|Africa', 'hCoV-19/South_Africa/KRISP-0458/2020|EPI_ISL_495549|2020-07-02|Africa', 'hCoV-19/South_Africa/LR00128/2020|EPI_ISL_514360|2020-07-20|Africa', 'hCoV-19/South_Africa/KRISP-K002680/2020|EPI_ISL_535544|2020-08-03|Africa', 'hCoV-19/South_Africa/KRISP-K002826/2020|EPI_ISL_602646|2020-09-01|Africa', 'hCoV-19/South_Africa/KRISP-K003683/2020|EPI_ISL_602866|2020-09-26|Africa', 'hCoV-19/South_Africa/KRISP-K002837/2020|EPI_ISL_602654|2020-08-31|Africa'], 'annotations': []}, {'cluster': 'c291', 'lineage': 'B.1.1.119', 'mutation': (20, 'T', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.14285714285714285, 'FC': 142857.14285714287, 'epi_start': 6, 'epi_stop': 34, 'epi_seq': 'VLLPLVSSQCVNLTTRTQLPPAYTNSFTR', '#linear': 12, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038063'], '#pubs linear': 8, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K002680/2020|EPI_ISL_535544|2020-08-03|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c291', 'lineage': 'B.1.1.119', 'mutation': (1149, 'K', 'R'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.2857142857142857, 'FC': 285714.28571428574, 'epi_start': 1135, 'epi_stop': 1165, 'epi_seq': 'NTVYDPLQPELDSFKEELDKYFKNHTSPDVD', '#linear': 17, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003683/2020|EPI_ISL_602866|2020-09-26|Africa', 'hCoV-19/South_Africa/KRISP-K002837/2020|EPI_ISL_602654|2020-08-31|Africa'], 'annotations': []}, {'cluster': 'c291', 'lineage': 'B.1.1.52', 'mutation': (614, 'D', 'G'), '# cluster': 2, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/LR00145/2020|EPI_ISL_514374|2020-07-20|Africa', 'hCoV-19/South_Africa/LR00081/2020|EPI_ISL_514392|2020-07-13|Africa'], 'annotations': []}, {'cluster': 'c293', 'lineage': 'B.1.1.281', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/India/MH-ACTREC-627/2020|EPI_ISL_700262|2020-09-11|Asia', 'hCoV-19/India/MH-ACTREC-363/2020|EPI_ISL_700012|2020-07-23|Asia', 'hCoV-19/Bahrain/02/2020|EPI_ISL_486887|2020-06-23|Asia', 'hCoV-19/India/MH-ACTREC-313/2020|EPI_ISL_699962|2020-07-15|Asia', 'hCoV-19/India/MH-ACTREC-497/2020|EPI_ISL_700145|2020-08-14|Asia', 'hCoV-19/India/MH-ACTREC-675/2020|EPI_ISL_700300|2020-09-18|Asia', 'hCoV-19/India/MH-ACTREC-568/2020|EPI_ISL_700212|2020-08-31|Asia'], 'annotations': []}, {'cluster': 'c293', 'lineage': 'B.1.1.281', 'mutation': (1063, 'L', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.14285714285714285, 'FC': 142857.14285714287, 'epi_start': 1046, 'epi_stop': 1096, 'epi_seq': 'GYHLMSFPQSAPHGVVFLHVTYVPAQEKNFTTAPAICHDGKAHFPREGVFV', '#linear': 17, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Bahrain/02/2020|EPI_ISL_486887|2020-06-23|Asia'], 'annotations': []}, {'cluster': 'c293', 'lineage': 'B.1.1.281', 'mutation': (946, 'G', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.14285714285714285, 'FC': 142857.14285714287, 'epi_start': 906, 'epi_stop': 968, 'epi_seq': 'FNGIGVTQNVLYENQKLIANQFNSAIGKIQDSLSSTASALGKLQDVVNQNAQALNTLVKQLSS', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/India/MH-ACTREC-675/2020|EPI_ISL_700300|2020-09-18|Asia'], 'annotations': ['heptapeptide repeat sequence 1']}, {'cluster': 'c293', 'lineage': 'B.1.1.306', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/India/MH-AFCO-7992/2020|EPI_ISL_722187|2020-06-15|Asia'], 'annotations': []}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (614, 'D', 'G'), '# cluster': 70, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002618/2020|EPI_ISL_535482|2020-07-29|Africa', 'hCoV-19/South_Africa/KRISP-K001071/2020|EPI_ISL_509325|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K004294/2020|EPI_ISL_660175|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K002642/2020|EPI_ISL_535512|2020-08-02|Africa', 'hCoV-19/South_Africa/KRISP-K003541/2020|EPI_ISL_602858|2020-09-25|Africa', 'hCoV-19/South_Africa/KRISP-K002703/2020|EPI_ISL_535563|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K001409/2020|EPI_ISL_515892|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-0492/2020|EPI_ISL_498063|2020-07-07|Africa', 'hCoV-19/South_Africa/KRISP-K003716/2020|EPI_ISL_602896|2020-10-07|Africa', 'hCoV-19/South_Africa/KRISP-K003723/2020|EPI_ISL_602901|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K004075/2020|EPI_ISL_635052|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K003346/2020|EPI_ISL_602738|2020-09-07|Africa', 'hCoV-19/South_Africa/KRISP-K003339/2020|EPI_ISL_602731|2020-09-07|Africa', 'hCoV-19/South_Africa/KRISP-K004313/2020|EPI_ISL_660191|2020-10-25|Africa', 'hCoV-19/South_Africa/KRISP-K004640/2020|EPI_ISL_660655|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-K003692/2020|EPI_ISL_602874|2020-10-05|Africa', 'hCoV-19/South_Africa/KRISP-K004340/2020|EPI_ISL_660216|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-K002395/2020|EPI_ISL_515760|2020-07-28|Africa', 'hCoV-19/South_Africa/KRISP-K000584/2020|EPI_ISL_509240|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-0556/2020|EPI_ISL_498095|2020-07-15|Africa', 'hCoV-19/South_Africa/KRISP-K002731/2020|EPI_ISL_529729|2020-08-16|Africa', 'hCoV-19/South_Africa/KRISP-K003387/2020|EPI_ISL_602775|2020-09-10|Africa', 'hCoV-19/South_Africa/KRISP-K003394/2020|EPI_ISL_602782|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K001038/2020|EPI_ISL_509303|2020-07-16|Africa', 'hCoV-19/South_Africa/KRISP-K002346/2020|EPI_ISL_515718|2020-07-23|Africa', 'hCoV-19/South_Africa/KRISP-K003363/2020|EPI_ISL_602754|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K002428/2020|EPI_ISL_515789|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K001041/2020|EPI_ISL_509304|2020-07-16|Africa', 'hCoV-19/South_Africa/KRISP-0545/2020|EPI_ISL_498086|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-K003388/2020|EPI_ISL_602776|2020-09-10|Africa', 'hCoV-19/South_Africa/KRISP-K000652/2020|EPI_ISL_509296|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-0277/2020|EPI_ISL_482864|2020-06-16|Africa', 'hCoV-19/South_Africa/KRISP-0367/2020|EPI_ISL_487318|2020-06-25|Africa', 'hCoV-19/South_Africa/KRISP-K003361/2020|EPI_ISL_602752|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K002889/2020|EPI_ISL_602701|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K002679/2020|EPI_ISL_535543|2020-08-02|Africa', 'hCoV-19/South_Africa/KRISP-K002495/2020|EPI_ISL_535396|2020-08-06|Africa', 'hCoV-19/South_Africa/KRISP-K003378/2020|EPI_ISL_602767|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K002690/2020|EPI_ISL_535552|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K003469/2020|EPI_ISL_602802|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K003993/2020|EPI_ISL_634981|2020-09-28|Africa', 'hCoV-19/South_Africa/KRISP-K002196/2020|EPI_ISL_515594|2020-07-05|Africa', 'hCoV-19/South_Africa/KRISP-K003464/2020|EPI_ISL_602798|2020-09-13|Africa', 'hCoV-19/South_Africa/KRISP-K002457/2020|EPI_ISL_518043|2020-07-07|Africa', 'hCoV-19/South_Africa/KRISP-K002456/2020|EPI_ISL_518042|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-K003734/2020|EPI_ISL_602912|2020-09-30|Africa', 'hCoV-19/South_Africa/KRISP-K002711/2020|EPI_ISL_535570|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K004068/2020|EPI_ISL_635046|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K004014/2020|EPI_ISL_634999|2020-10-12|Africa', 'hCoV-19/South_Africa/KRISP-K003701/2020|EPI_ISL_602881|2020-10-04|Africa', 'hCoV-19/South_Africa/KRISP-K003325/2020|EPI_ISL_602718|2020-09-07|Africa', 'hCoV-19/South_Africa/KRISP-K002204/2020|EPI_ISL_515602|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K002455/2020|EPI_ISL_518041|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K001354/2020|EPI_ISL_515839|2020-07-01|Africa', 'hCoV-19/South_Africa/KRISP-K002583/2020|EPI_ISL_535448|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-0548/2020|EPI_ISL_498087|2020-07-15|Africa', 'hCoV-19/South_Africa/KRISP-K003396/2020|EPI_ISL_602784|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K003397/2020|EPI_ISL_602785|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K002206/2020|EPI_ISL_515604|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K003343/2020|EPI_ISL_602735|2020-09-05|Africa', 'hCoV-19/South_Africa/KRISP-K004029/2020|EPI_ISL_635010|2020-10-09|Africa', 'hCoV-19/South_Africa/KRISP-K003674/2020|EPI_ISL_602630|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K002554/2020|EPI_ISL_535423|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K004306/2020|EPI_ISL_660185|2020-10-05|Africa', 'hCoV-19/South_Africa/KRISP-0503/2020|EPI_ISL_498071|2020-07-11|Africa', 'hCoV-19/South_Africa/KRISP-0502/2020|EPI_ISL_498070|2020-07-11|Africa', 'hCoV-19/South_Africa/KRISP-K003390/2020|EPI_ISL_602778|2020-09-10|Africa', 'hCoV-19/South_Africa/KRISP-K001079/2020|EPI_ISL_509333|2020-07-03|Africa', 'hCoV-19/South_Africa/KRISP-K001368/2020|EPI_ISL_515853|2020-07-15|Africa', 'hCoV-19/South_Africa/KRISP-K002365/2020|EPI_ISL_515733|2020-07-22|Africa'], 'annotations': []}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (1235, 'C', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 1202, 'epi_stop': 1250, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLKGCCSC', '#linear': 9, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 4, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003541/2020|EPI_ISL_602858|2020-09-25|Africa'], 'annotations': ['TM domain']}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (483, 'V', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 464, 'epi_stop': 513, 'epi_seq': 'FERDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 25, '#non-linear': 18, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1036858', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474'], '#pubs linear': 15, '#pubs non-linear': 17, 'sequences': ['hCoV-19/South_Africa/KRISP-K004340/2020|EPI_ISL_660216|2020-10-29|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (812, 'P', 'L'), '# cluster': 11, '% lineage': 0.0, '% cluster': 0.15714285714285714, 'FC': 157142.85714285716, 'epi_start': 779, 'epi_stop': 837, 'epi_seq': 'QEVFAQVKQIYKTPPIKDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQY', '#linear': 33, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 14, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003387/2020|EPI_ISL_602775|2020-09-10|Africa', 'hCoV-19/South_Africa/KRISP-K003394/2020|EPI_ISL_602782|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K001038/2020|EPI_ISL_509303|2020-07-16|Africa', 'hCoV-19/South_Africa/KRISP-K002346/2020|EPI_ISL_515718|2020-07-23|Africa', 'hCoV-19/South_Africa/KRISP-K003363/2020|EPI_ISL_602754|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K002428/2020|EPI_ISL_515789|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K001041/2020|EPI_ISL_509304|2020-07-16|Africa', 'hCoV-19/South_Africa/KRISP-0545/2020|EPI_ISL_498086|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-K003388/2020|EPI_ISL_602776|2020-09-10|Africa', 'hCoV-19/South_Africa/KRISP-K000652/2020|EPI_ISL_509296|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-0277/2020|EPI_ISL_482864|2020-06-16|Africa'], 'annotations': []}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (1143, 'P', 'L'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 1129, 'epi_stop': 1165, 'epi_seq': 'VIGIVNNTVYDPLQPELDSFKEELDKYFKNHTSPDVD', '#linear': 15, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002679/2020|EPI_ISL_535543|2020-08-02|Africa'], 'annotations': []}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (1084, 'D', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 1054, 'epi_stop': 1098, 'epi_seq': 'QSAPHGVVFLHVTYVPAQEKNFTTAPAICHDGKAHFPREGVFVSN', '#linear': 25, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002495/2020|EPI_ISL_535396|2020-08-06|Africa'], 'annotations': []}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (142, 'G', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 122, 'epi_stop': 171, 'epi_seq': 'NATNVVIKVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYV', '#linear': 34, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038080', 'http://www.iedb.org/reference/1038547', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 12, '#pubs non-linear': 5, 'sequences': ['hCoV-19/South_Africa/KRISP-K003734/2020|EPI_ISL_602912|2020-09-30|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (796, 'D', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 779, 'epi_stop': 837, 'epi_seq': 'QEVFAQVKQIYKTPPIKDFGGFNFSQILPDPSKPSKRSFIEDLLFNKVTLADAGFIKQY', '#linear': 19, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003734/2020|EPI_ISL_602912|2020-09-30|Africa'], 'annotations': ['fusion peptide']}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (706, 'A', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 17, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003701/2020|EPI_ISL_602881|2020-10-04|Africa'], 'annotations': []}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (655, 'H', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 641, 'epi_stop': 689, 'epi_seq': 'NVFQTRAGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVAS', '#linear': 14, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242'], '#pubs linear': 7, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K004029/2020|EPI_ISL_635010|2020-10-09|Africa'], 'annotations': []}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (484, 'E', 'K'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.014285714285714285, 'FC': 14285.714285714286, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-K004306/2020|EPI_ISL_660185|2020-10-05|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c299', 'lineage': 'B.1.1.273', 'mutation': (1074, 'N', 'H'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.02857142857142857, 'FC': 28571.428571428572, 'epi_start': 1054, 'epi_stop': 1096, 'epi_seq': 'QSAPHGVVFLHVTYVPAQEKNFTTAPAICHDGKAHFPREGVFV', '#linear': 16, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0503/2020|EPI_ISL_498071|2020-07-11|Africa', 'hCoV-19/South_Africa/KRISP-0502/2020|EPI_ISL_498070|2020-07-11|Africa'], 'annotations': []}, {'cluster': 'c301', 'lineage': 'B.1.1.273', 'mutation': (614, 'D', 'G'), '# cluster': 11, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004601/2020|EPI_ISL_660630|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004034/2020|EPI_ISL_635015|2020-10-14|Africa', 'hCoV-19/South_Africa/KRISP-K004336/2020|EPI_ISL_660212|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004032/2020|EPI_ISL_635013|2020-10-12|Africa', 'hCoV-19/South_Africa/KRISP-K004030/2020|EPI_ISL_635011|2020-10-12|Africa', 'hCoV-19/South_Africa/KRISP-K005306/2020|EPI_ISL_678599|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-K004031/2020|EPI_ISL_635012|2020-10-12|Africa', 'hCoV-19/South_Africa/KRISP-K002634/2020|EPI_ISL_535504|2020-08-03|Africa', 'hCoV-19/South_Africa/KRISP-K002464/2020|EPI_ISL_518047|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-0579/2020|EPI_ISL_498117|2020-07-08|Africa', 'hCoV-19/South_Africa/KRISP-0586/2020|EPI_ISL_498124|2020-07-08|Africa'], 'annotations': []}, {'cluster': 'c301', 'lineage': 'B.1.1.273', 'mutation': (689, 'S', 'I'), '# cluster': 7, '% lineage': 0.0, '% cluster': 0.6363636363636364, 'FC': 636363.6363636364, 'epi_start': 647, 'epi_stop': 726, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 40, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004601/2020|EPI_ISL_660630|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004034/2020|EPI_ISL_635015|2020-10-14|Africa', 'hCoV-19/South_Africa/KRISP-K004336/2020|EPI_ISL_660212|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004032/2020|EPI_ISL_635013|2020-10-12|Africa', 'hCoV-19/South_Africa/KRISP-K004030/2020|EPI_ISL_635011|2020-10-12|Africa', 'hCoV-19/South_Africa/KRISP-K005306/2020|EPI_ISL_678599|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-K004031/2020|EPI_ISL_635012|2020-10-12|Africa'], 'annotations': []}, {'cluster': 'c301', 'lineage': 'B.1.146', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K005326/2020|EPI_ISL_678616|2020-11-16|Africa'], 'annotations': []}, {'cluster': 'c301', 'lineage': 'B.1.146', 'mutation': (689, 'S', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 647, 'epi_stop': 726, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 40, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K005326/2020|EPI_ISL_678616|2020-11-16|Africa'], 'annotations': []}, {'cluster': 'c310', 'lineage': 'H.1', 'mutation': (614, 'D', 'G'), '# cluster': 9, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004278-CE1/2020|EPI_ISL_660162|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004365-CE1/2020|EPI_ISL_660227|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004276-CE1/2020|EPI_ISL_660160|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004275-CE1/2020|EPI_ISL_660159|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004280-CE1/2020|EPI_ISL_660163|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004277-CE1/2020|EPI_ISL_660161|2020-11-05|Africa', 'hCoV-19/South_Africa/KRISP-K004357-CE1/2020|EPI_ISL_660225|2020-11-02|Africa', 'hCoV-19/South_Africa/KRISP-K005328/2020|EPI_ISL_678617|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004281-CE1/2020|EPI_ISL_660164|2020-11-05|Africa'], 'annotations': []}, {'cluster': 'c320', 'lineage': 'B.1.1.67', 'mutation': (255, 'S', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 240, 'epi_stop': 282, 'epi_seq': 'TLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004551/2020|EPI_ISL_660248|2020-10-27|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c320', 'lineage': 'B.1.1.67', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004551/2020|EPI_ISL_660248|2020-10-27|Africa'], 'annotations': []}, {'cluster': 'c320', 'lineage': 'H.1', 'mutation': (255, 'S', 'Y'), '# cluster': 4, '% lineage': 0.0, '% cluster': 0.6666666666666666, 'FC': 666666.6666666666, 'epi_start': 240, 'epi_stop': 282, 'epi_seq': 'TLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K005308/2020|EPI_ISL_678601|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004321/2020|EPI_ISL_660197|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004080/2020|EPI_ISL_635056|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004060/2020|EPI_ISL_635039|2020-10-20|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c320', 'lineage': 'H.1', 'mutation': (614, 'D', 'G'), '# cluster': 6, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K005308/2020|EPI_ISL_678601|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004321/2020|EPI_ISL_660197|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004080/2020|EPI_ISL_635056|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004060/2020|EPI_ISL_635039|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K003704/2020|EPI_ISL_602884|2020-10-04|Africa', 'hCoV-19/South_Africa/KRISP-K003712/2020|EPI_ISL_602892|2020-10-03|Africa'], 'annotations': []}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (614, 'D', 'G'), '# cluster': 23, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-0571/2020|EPI_ISL_498109|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-0570/2020|EPI_ISL_498108|2020-07-02|Africa', 'hCoV-19/South_Africa/KRISP-K002616/2020|EPI_ISL_535480|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K002658/2020|EPI_ISL_535526|2020-08-03|Africa', 'hCoV-19/South_Africa/KRISP-K001342/2020|EPI_ISL_515827|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001341/2020|EPI_ISL_515826|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001343/2020|EPI_ISL_515828|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K004616/2020|EPI_ISL_660638|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K002256/2020|EPI_ISL_515641|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K003334/2020|EPI_ISL_602726|2020-09-05|Africa', 'hCoV-19/South_Africa/KRISP-K004021/2020|EPI_ISL_635004|2020-10-13|Africa', 'hCoV-19/South_Africa/KRISP-K003991/2020|EPI_ISL_634979|2020-09-25|Africa', 'hCoV-19/South_Africa/KRISP-K004027/2020|EPI_ISL_635009|2020-10-14|Africa', 'hCoV-19/South_Africa/KRISP-K003720/2020|EPI_ISL_605787|2020-10-07|Africa', 'hCoV-19/South_Africa/KRISP-K003729/2020|EPI_ISL_602907|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K004540/2020|EPI_ISL_660238|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K002761/2020|EPI_ISL_529757|2020-08-15|Africa', 'hCoV-19/South_Africa/KRISP-0587/2020|EPI_ISL_498125|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0577/2020|EPI_ISL_498115|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0582/2020|EPI_ISL_498120|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0583/2020|EPI_ISL_498121|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-K003386/2020|EPI_ISL_602774|2020-09-10|Africa', 'hCoV-19/South_Africa/KRISP-K001087/2020|EPI_ISL_509339|2020-07-13|Africa'], 'annotations': []}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (769, 'G', 'V'), '# cluster': 22, '% lineage': 0.0, '% cluster': 0.9565217391304348, 'FC': 956521.7391304348, 'epi_start': 753, 'epi_stop': 788, 'epi_seq': 'LLQYGSFCTQLNRALTGIAVEQDKNTQEVFAQVKQI', '#linear': 25, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0571/2020|EPI_ISL_498109|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-0570/2020|EPI_ISL_498108|2020-07-02|Africa', 'hCoV-19/South_Africa/KRISP-K002616/2020|EPI_ISL_535480|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K002658/2020|EPI_ISL_535526|2020-08-03|Africa', 'hCoV-19/South_Africa/KRISP-K001342/2020|EPI_ISL_515827|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001341/2020|EPI_ISL_515826|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001343/2020|EPI_ISL_515828|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K004616/2020|EPI_ISL_660638|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K002256/2020|EPI_ISL_515641|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K003334/2020|EPI_ISL_602726|2020-09-05|Africa', 'hCoV-19/South_Africa/KRISP-K004021/2020|EPI_ISL_635004|2020-10-13|Africa', 'hCoV-19/South_Africa/KRISP-K003991/2020|EPI_ISL_634979|2020-09-25|Africa', 'hCoV-19/South_Africa/KRISP-K004027/2020|EPI_ISL_635009|2020-10-14|Africa', 'hCoV-19/South_Africa/KRISP-K003720/2020|EPI_ISL_605787|2020-10-07|Africa', 'hCoV-19/South_Africa/KRISP-K003729/2020|EPI_ISL_602907|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K004540/2020|EPI_ISL_660238|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K002761/2020|EPI_ISL_529757|2020-08-15|Africa', 'hCoV-19/South_Africa/KRISP-0577/2020|EPI_ISL_498115|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0582/2020|EPI_ISL_498120|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0583/2020|EPI_ISL_498121|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-K003386/2020|EPI_ISL_602774|2020-09-10|Africa', 'hCoV-19/South_Africa/KRISP-K001087/2020|EPI_ISL_509339|2020-07-13|Africa'], 'annotations': []}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (1078, 'A', 'S'), '# cluster': 22, '% lineage': 0.0, '% cluster': 0.9565217391304348, 'FC': 956521.7391304348, 'epi_start': 1054, 'epi_stop': 1096, 'epi_seq': 'QSAPHGVVFLHVTYVPAQEKNFTTAPAICHDGKAHFPREGVFV', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0571/2020|EPI_ISL_498109|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-0570/2020|EPI_ISL_498108|2020-07-02|Africa', 'hCoV-19/South_Africa/KRISP-K002616/2020|EPI_ISL_535480|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K002658/2020|EPI_ISL_535526|2020-08-03|Africa', 'hCoV-19/South_Africa/KRISP-K001342/2020|EPI_ISL_515827|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001341/2020|EPI_ISL_515826|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001343/2020|EPI_ISL_515828|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K004616/2020|EPI_ISL_660638|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K002256/2020|EPI_ISL_515641|2020-07-21|Africa', 'hCoV-19/South_Africa/KRISP-K003334/2020|EPI_ISL_602726|2020-09-05|Africa', 'hCoV-19/South_Africa/KRISP-K004021/2020|EPI_ISL_635004|2020-10-13|Africa', 'hCoV-19/South_Africa/KRISP-K003991/2020|EPI_ISL_634979|2020-09-25|Africa', 'hCoV-19/South_Africa/KRISP-K004027/2020|EPI_ISL_635009|2020-10-14|Africa', 'hCoV-19/South_Africa/KRISP-K003720/2020|EPI_ISL_605787|2020-10-07|Africa', 'hCoV-19/South_Africa/KRISP-K003729/2020|EPI_ISL_602907|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K004540/2020|EPI_ISL_660238|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K002761/2020|EPI_ISL_529757|2020-08-15|Africa', 'hCoV-19/South_Africa/KRISP-0587/2020|EPI_ISL_498125|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0577/2020|EPI_ISL_498115|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0582/2020|EPI_ISL_498120|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-0583/2020|EPI_ISL_498121|2020-07-09|Africa', 'hCoV-19/South_Africa/KRISP-K001087/2020|EPI_ISL_509339|2020-07-13|Africa'], 'annotations': []}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (155, 'S', 'T'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.043478260869565216, 'FC': 43478.260869565216, 'epi_start': 129, 'epi_stop': 171, 'epi_seq': 'KVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYV', '#linear': 14, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038063'], '#pubs linear': 8, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-0570/2020|EPI_ISL_498108|2020-07-02|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (1263, 'P', 'L'), '# cluster': 5, '% lineage': 0.0, '% cluster': 0.21739130434782608, 'FC': 217391.30434782608, 'epi_start': 1246, 'epi_stop': 1273, 'epi_seq': 'GCCSCGSCCKFDEDDSEPVLKGVKLHYT', '#linear': 18, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002616/2020|EPI_ISL_535480|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K002658/2020|EPI_ISL_535526|2020-08-03|Africa', 'hCoV-19/South_Africa/KRISP-K001342/2020|EPI_ISL_515827|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001341/2020|EPI_ISL_515826|2020-07-10|Africa', 'hCoV-19/South_Africa/KRISP-K001343/2020|EPI_ISL_515828|2020-07-10|Africa'], 'annotations': ['cytoplasm domain']}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (475, 'A', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.043478260869565216, 'FC': 43478.260869565216, 'epi_start': 457, 'epi_stop': 513, 'epi_seq': 'RKSNLKPFERDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 43, '#non-linear': 44, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036858', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 10, '#pubs non-linear': 26, 'sequences': ['hCoV-19/South_Africa/KRISP-K004616/2020|EPI_ISL_660638|2020-11-04|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (95, 'T', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.043478260869565216, 'FC': 43478.260869565216, 'epi_start': 81, 'epi_stop': 134, 'epi_seq': 'NPVLPFNDGVYFASTEKSNIIRGWIFGTTLDSKTQSLLIVNNATNVVIKVCEFQ', '#linear': 16, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 9, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K003334/2020|EPI_ISL_602726|2020-09-05|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c326', 'lineage': 'B.1.1.56', 'mutation': (49, 'H', 'Y'), '# cluster': 6, '% lineage': 0.0, '% cluster': 0.2608695652173913, 'FC': 260869.5652173913, 'epi_start': 31, 'epi_stop': 66, 'epi_seq': 'SFTRGVYYPDKVFRSSVLHSTQDLFLPFFSNVTWFH', '#linear': 26, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004021/2020|EPI_ISL_635004|2020-10-13|Africa', 'hCoV-19/South_Africa/KRISP-K003991/2020|EPI_ISL_634979|2020-09-25|Africa', 'hCoV-19/South_Africa/KRISP-K004027/2020|EPI_ISL_635009|2020-10-14|Africa', 'hCoV-19/South_Africa/KRISP-K003720/2020|EPI_ISL_605787|2020-10-07|Africa', 'hCoV-19/South_Africa/KRISP-K003729/2020|EPI_ISL_602907|2020-10-06|Africa', 'hCoV-19/South_Africa/KRISP-K004540/2020|EPI_ISL_660238|2020-10-18|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c329', 'lineage': 'B.1.1.119', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1779/2020|EPI_ISL_640112|2020-09-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GP-5223/2020|EPI_ISL_640102|2020-04-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0768/2020|EPI_ISL_640069|2020-07-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1532/2020|EPI_ISL_700465|2020-08-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0034/2020|EPI_ISL_640035|2020-08-20|Africa'], 'annotations': []}, {'cluster': 'c329', 'lineage': 'B.1.1.208', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-0289/2020|EPI_ISL_640068|2020-07-08|Africa'], 'annotations': []}, {'cluster': 'c329', 'lineage': 'B.1.1.37', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-0016/2020|EPI_ISL_640018|2020-08-11|Africa'], 'annotations': []}, {'cluster': 'c329', 'lineage': 'B.1.1.62', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-0129/2020|EPI_ISL_467481|2020-05-13|Africa', 'hCoV-19/South_Africa/KRISP-0137/2020|EPI_ISL_467489|2020-05-14|Africa', 'hCoV-19/South_Africa/KRISP-0125/2020|EPI_ISL_467477|2020-05-13|Africa', 'hCoV-19/South_Africa/R13317-20/2020|EPI_ISL_622939|2020-07-02|Africa', 'hCoV-19/South_Africa/R10752/2020|EPI_ISL_490302|2020-06-12|Africa', 'hCoV-19/South_Africa/R10166/2020|EPI_ISL_490260|2020-05-20|Africa', 'hCoV-19/South_Africa/R10755/2020|EPI_ISL_490303|2020-06-12|Africa'], 'annotations': []}, {'cluster': 'c334', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 8, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K001335/2020|EPI_ISL_515820|2020-07-19|Africa', 'hCoV-19/South_Africa/KRISP-0418/2020|EPI_ISL_495542|2020-07-02|Africa', 'hCoV-19/South_Africa/KRISP-K002692/2020|EPI_ISL_535554|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K004544/2020|EPI_ISL_660241|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-K003707/2020|EPI_ISL_602887|2020-10-04|Africa', 'hCoV-19/South_Africa/KRISP-K004539/2020|EPI_ISL_660237|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K002290/2020|EPI_ISL_515668|2020-07-23|Africa', 'hCoV-19/South_Africa/KRISP-K002302/2020|EPI_ISL_515679|2020-07-23|Africa'], 'annotations': []}, {'cluster': 'c334', 'lineage': 'B.1.1.206', 'mutation': (655, 'H', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.125, 'FC': 125000.0, 'epi_start': 641, 'epi_stop': 689, 'epi_seq': 'NVFQTRAGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVAS', '#linear': 14, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242'], '#pubs linear': 7, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-0418/2020|EPI_ISL_495542|2020-07-02|Africa'], 'annotations': []}, {'cluster': 'c334', 'lineage': 'B.1.1.206', 'mutation': (618, 'T', 'R'), '# cluster': 3, '% lineage': 0.0, '% cluster': 0.375, 'FC': 375000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004544/2020|EPI_ISL_660241|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-K003707/2020|EPI_ISL_602887|2020-10-04|Africa', 'hCoV-19/South_Africa/KRISP-K004539/2020|EPI_ISL_660237|2020-10-18|Africa'], 'annotations': []}, {'cluster': 'c342', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 9, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K003520/2020|EPI_ISL_602839|2020-09-25|Africa', 'hCoV-19/South_Africa/KRISP-K004543/2020|EPI_ISL_660240|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-K004352-CE1/2020|EPI_ISL_660224|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004597/2020|EPI_ISL_660627|2020-11-07|Africa', 'hCoV-19/South_Africa/KRISP-K005313/2020|EPI_ISL_678606|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-CH01110237/2020|EPI_ISL_736987|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-CH01110222/2020|EPI_ISL_736985|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-CH01110224/2020|EPI_ISL_736986|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K005322/2020|EPI_ISL_678612|2020-11-15|Africa'], 'annotations': []}, {'cluster': 'c342', 'lineage': 'B.1.1.206', 'mutation': (1237, 'M', 'I'), '# cluster': 5, '% lineage': 0.0, '% cluster': 0.5555555555555556, 'FC': 555555.5555555556, 'epi_start': 1202, 'epi_stop': 1255, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLKGCCSCGSCCK', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K005313/2020|EPI_ISL_678606|2020-10-29|Africa', 'hCoV-19/South_Africa/KRISP-CH01110237/2020|EPI_ISL_736987|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-CH01110222/2020|EPI_ISL_736985|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-CH01110224/2020|EPI_ISL_736986|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K005322/2020|EPI_ISL_678612|2020-11-15|Africa'], 'annotations': ['TM domain', 'cytoplasm domain']}, {'cluster': 'c347', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002377/2020|EPI_ISL_515743|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002338/2020|EPI_ISL_515712|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002333/2020|EPI_ISL_515708|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002325/2020|EPI_ISL_515701|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002326/2020|EPI_ISL_515702|2020-07-22|Africa'], 'annotations': []}, {'cluster': 'c347', 'lineage': 'B.1.1.206', 'mutation': (769, 'G', 'V'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.4, 'FC': 400000.00000000006, 'epi_start': 753, 'epi_stop': 788, 'epi_seq': 'LLQYGSFCTQLNRALTGIAVEQDKNTQEVFAQVKQI', '#linear': 25, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002325/2020|EPI_ISL_515701|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K002326/2020|EPI_ISL_515702|2020-07-22|Africa'], 'annotations': []}, {'cluster': 'c350', 'lineage': 'B.1.1.206', 'mutation': (153, 'M', 'I'), '# cluster': 8, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 129, 'epi_stop': 171, 'epi_seq': 'KVCEFQFCNDPFLGVYYHKNNKSWMESEFRVYSSANNCTFEYV', '#linear': 17, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038547'], '#pubs linear': 9, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K004079/2020|EPI_ISL_635055|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004735/2020|EPI_ISL_660263|2020-10-21|Africa', 'hCoV-19/South_Africa/KRISP-K004078/2020|EPI_ISL_635054|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004542/2020|EPI_ISL_660239|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-EB00584394/2020|EPI_ISL_736988|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K004351-CE1/2020|EPI_ISL_660223|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004591/2020|EPI_ISL_660621|2020-11-07|Africa', 'hCoV-19/South_Africa/KRISP-K003688/2020|EPI_ISL_602870|2020-10-05|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c350', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 8, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004079/2020|EPI_ISL_635055|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004735/2020|EPI_ISL_660263|2020-10-21|Africa', 'hCoV-19/South_Africa/KRISP-K004078/2020|EPI_ISL_635054|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004542/2020|EPI_ISL_660239|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-EB00584394/2020|EPI_ISL_736988|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K004351-CE1/2020|EPI_ISL_660223|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K004591/2020|EPI_ISL_660621|2020-11-07|Africa', 'hCoV-19/South_Africa/KRISP-K003688/2020|EPI_ISL_602870|2020-10-05|Africa'], 'annotations': []}, {'cluster': 'c350', 'lineage': 'B.1.1.206', 'mutation': (574, 'D', 'Y'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.125, 'FC': 125000.0, 'epi_start': 561, 'epi_stop': 593, 'epi_seq': 'PFQQFGRDIADTTDAVRDPQTLEILDITPCSFG', '#linear': 15, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004591/2020|EPI_ISL_660621|2020-11-07|Africa'], 'annotations': []}, {'cluster': 'c371', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 11, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004626/2020|EPI_ISL_660642|2020-11-02|Africa', 'hCoV-19/South_Africa/KRISP-K004731/2020|EPI_ISL_660259|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K003737/2020|EPI_ISL_602914|2020-09-28|Africa', 'hCoV-19/South_Africa/KRISP-K004003/2020|EPI_ISL_634988|2020-09-28|Africa', 'hCoV-19/South_Africa/KRISP-K003509/2020|EPI_ISL_602832|2020-09-26|Africa', 'hCoV-19/South_Africa/KRISP-K004052/2020|EPI_ISL_635031|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004062/2020|EPI_ISL_635041|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K003511/2020|EPI_ISL_602833|2020-09-26|Africa', 'hCoV-19/South_Africa/KRISP-K003400/2020|EPI_ISL_602788|2020-09-11|Africa', 'hCoV-19/South_Africa/KRISP-K003547/2020|EPI_ISL_602863|2020-09-25|Africa', 'hCoV-19/South_Africa/KRISP-K004634/2020|EPI_ISL_660650|2020-11-02|Africa'], 'annotations': []}, {'cluster': 'c371', 'lineage': 'B.1.1.206', 'mutation': (184, 'G', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.09090909090909091, 'FC': 90909.09090909091, 'epi_start': 169, 'epi_stop': 203, 'epi_seq': 'EYVSQPFLMDLEGKQGNFKNLREFVFKNIDGYFKI', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004731/2020|EPI_ISL_660259|2020-10-20|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c375', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 13, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K003364/2020|EPI_ISL_602755|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K003367/2020|EPI_ISL_602758|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K003366/2020|EPI_ISL_602757|2020-09-04|Africa', 'hCoV-19/South_Africa/LR00003/2020|EPI_ISL_515135|2020-07-03|Africa', 'hCoV-19/South_Africa/KRISP-K001392/2020|EPI_ISL_515876|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K001384/2020|EPI_ISL_515868|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K001398/2020|EPI_ISL_515881|2020-07-18|Africa', 'hCoV-19/South_Africa/LR00113/2020|EPI_ISL_514407|2020-07-20|Africa', 'hCoV-19/South_Africa/KRISP-K002218/2020|EPI_ISL_515615|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K003401/2020|EPI_ISL_602789|2020-09-11|Africa', 'hCoV-19/South_Africa/L00181/2020|EPI_ISL_622959|2020-07-27|Africa', 'hCoV-19/South_Africa/L00161/2020|EPI_ISL_622964|2020-07-26|Africa', 'hCoV-19/South_Africa/LR00073/2020|EPI_ISL_514384|2020-07-13|Africa'], 'annotations': []}, {'cluster': 'c375', 'lineage': 'B.1.1.206', 'mutation': (1176, 'V', 'F'), '# cluster': 3, '% lineage': 0.0, '% cluster': 0.23076923076923078, 'FC': 230769.23076923078, 'epi_start': 1155, 'epi_stop': 1207, 'epi_seq': 'YFKNHTSPDVDLGDISGINASVVNIQKEIDRLNEVAKNLNESLIDLQELGKYE', '#linear': 32, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K003364/2020|EPI_ISL_602755|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K003367/2020|EPI_ISL_602758|2020-09-04|Africa', 'hCoV-19/South_Africa/KRISP-K003366/2020|EPI_ISL_602757|2020-09-04|Africa'], 'annotations': ['heptapeptide repeat sequence 2']}, {'cluster': 'c375', 'lineage': 'B.1.1.206', 'mutation': (477, 'S', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.07692307692307693, 'FC': 76923.07692307694, 'epi_start': 458, 'epi_stop': 513, 'epi_seq': 'KSNLKPFERDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 35, '#non-linear': 28, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038157'], '#pubs linear': 10, '#pubs non-linear': 17, 'sequences': ['hCoV-19/South_Africa/L00161/2020|EPI_ISL_622964|2020-07-26|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c375', 'lineage': 'B.1.1.54', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Taiwan/NTU30/2020|EPI_ISL_534336|2020-08-11|Asia'], 'annotations': []}, {'cluster': 'c379', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002498/2020|EPI_ISL_535397|2020-08-05|Africa', 'hCoV-19/South_Africa/KRISP-K002769/2020|EPI_ISL_529764|2020-08-21|Africa', 'hCoV-19/South_Africa/UFS-VIRO-NGS-70/2020|EPI_ISL_912537|2020-07-14|Africa', 'hCoV-19/South_Africa/KRISP-K002700/2020|EPI_ISL_535561|2020-07-30|Africa', 'hCoV-19/South_Africa/KRISP-K002624/2020|EPI_ISL_535487|2020-08-01|Africa'], 'annotations': []}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (27, 'A', 'S'), '# cluster': 19, '% lineage': 0.046511627906976744, '% cluster': 1.0, 'FC': 21.49953775993816, 'epi_start': 13, 'epi_stop': 43, 'epi_seq': 'SQCVNLTTRTQLPPAYTNSFTRGVYYPDKVF', '#linear': 14, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 19, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 19, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 19, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 18, '% lineage': 0.9022198731501057, '% cluster': 0.9473684210526315, 'FC': 1.0500404604305962, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 18, '% lineage': 0.9022198731501057, '% cluster': 0.9473684210526315, 'FC': 1.0500404604305962, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 19, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 19, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 19, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 19, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': []}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 19, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007853/2020|EPI_ISL_860618|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007837/2020|EPI_ISL_860605|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007742/2020|EPI_ISL_825473|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007840/2020|EPI_ISL_860607|2020-12-24|Africa', 'hCoV-19/South_Africa/KRISP-K007737/2020|EPI_ISL_825474|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007720/2020|EPI_ISL_825476|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa', 'hCoV-19/South_Africa/KRISP-K007848/2020|EPI_ISL_860614|2020-12-25|Africa', 'hCoV-19/Mozambique/INS-K007918/2020|EPI_ISL_887440|2020-12-27|Africa', 'hCoV-19/SouthAfrica/KRISP-K007629/2020|EPI_ISL_825134|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-EG00467189/2020|EPI_ISL_736955|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007866/2020|EPI_ISL_860627|2020-12-18|Africa', 'hCoV-19/England/210241183/2021|EPI_ISL_837196|2021-01-12|Europe', 'hCoV-19/South_Africa/KRISP-K007792/2020|EPI_ISL_860566|2020-12-26|Africa', 'hCoV-19/South_Africa/KRISP-K007830/2020|EPI_ISL_860598|2020-12-21|Africa', 'hCoV-19/South_Africa/KRISP-K007766/2020|EPI_ISL_825471|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007751/2020|EPI_ISL_825470|2020-12-15|Africa'], 'annotations': []}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (240, 'T', '-'), '# cluster': 1, '% lineage': 0.0036997885835095136, '% cluster': 0.05263157894736842, 'FC': 14.22171998203072, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 22, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (242, 'L', '#'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.05263157894736842, 'FC': 52631.57894736842, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (243, 'A', '#'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.05263157894736842, 'FC': 52631.57894736842, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K007730/2020|EPI_ISL_825477|2020-12-15|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c38', 'lineage': 'B.1.351', 'mutation': (209, 'P', 'H'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.10526315789473684, 'FC': 105263.15789473684, 'epi_start': 186, 'epi_stop': 226, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPL', '#linear': 45, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 14, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K007805/2021|EPI_ISL_860578|2021-01-02|Africa', 'hCoV-19/South_Africa/KRISP-K007841/2020|EPI_ISL_860608|2020-12-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c384', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K001403/2020|EPI_ISL_515886|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K002368/2020|EPI_ISL_515736|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-K001399/2020|EPI_ISL_515882|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K001404/2020|EPI_ISL_515887|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K001408/2020|EPI_ISL_515891|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K001402/2020|EPI_ISL_515885|2020-07-18|Africa', 'hCoV-19/South_Africa/KRISP-K002216/2020|EPI_ISL_515613|2020-07-18|Africa'], 'annotations': []}, {'cluster': 'c389', 'lineage': 'B.1.1.206', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002729/2020|EPI_ISL_529728|2020-08-14|Africa', 'hCoV-19/South_Africa/KRISP-0321/2020|EPI_ISL_487298|2020-06-24|Africa', 'hCoV-19/South_Africa/KRISP-K000582/2020|EPI_ISL_509238|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002862/2020|EPI_ISL_602676|2020-08-31|Africa', 'hCoV-19/South_Africa/KRISP-0331/2020|EPI_ISL_487302|2020-06-24|Africa'], 'annotations': []}, {'cluster': 'c389', 'lineage': 'B.1.1.206', 'mutation': (1237, 'M', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.2, 'FC': 200000.00000000003, 'epi_start': 1202, 'epi_stop': 1255, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLKGCCSCGSCCK', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0321/2020|EPI_ISL_487298|2020-06-24|Africa'], 'annotations': ['TM domain', 'cytoplasm domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 82, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 82, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 82, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 82, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 82, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 82, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 82, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 82, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': []}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 82, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/Tygerberg-457/2020|EPI_ISL_745183|2020-12-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': []}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (246, 'R', 'I'), '# cluster': 81, '% lineage': 0.003171247357293869, '% cluster': 0.9878048780487805, 'FC': 311.3896133533047, 'epi_start': 233, 'epi_stop': 282, 'epi_seq': 'INITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 19, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1037008', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038547', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 11, '#pubs non-linear': 6, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1067/2020|EPI_ISL_700428|2020-10-30|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1358/2020|EPI_ISL_700432|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0669/2020|EPI_ISL_700482|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1071/2020|EPI_ISL_700540|2020-10-26|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7035-KRISP/2020|EPI_ISL_696501|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0662/2020|EPI_ISL_700460|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1377/2020|EPI_ISL_700505|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1349/2020|EPI_ISL_700531|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7032-KRISP/2020|EPI_ISL_696520|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0633/2020|EPI_ISL_700478|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7001-KRISP/2020|EPI_ISL_696458|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1314/2020|EPI_ISL_700458|2020-11-02|Africa', 'hCoV-19/SouthAfrica/KRISP-K006840/2020|EPI_ISL_825109|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1042/2020|EPI_ISL_700563|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1079/2020|EPI_ISL_700464|2020-10-29|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1198/2020|EPI_ISL_700496|2020-11-03|Africa', 'hCoV-19/South_Africa/KRISP-EC-K005341/2020|EPI_ISL_678626|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7036-KRISP/2020|EPI_ISL_696507|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3467-KRISP/2020|EPI_ISL_696471|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1362/2020|EPI_ISL_700550|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7038-KRISP/2020|EPI_ISL_696497|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1851-KRISP/2020|EPI_ISL_696466|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1291/2020|EPI_ISL_700449|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1028/2020|EPI_ISL_700590|2020-10-27|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1047/2020|EPI_ISL_700539|2020-10-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7003-KRISP/2020|EPI_ISL_696478|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0684/2020|EPI_ISL_700535|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7012-KRISP/2020|EPI_ISL_696463|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0677/2020|EPI_ISL_700469|2020-10-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3569-KRISP/2020|EPI_ISL_696488|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1376/2020|EPI_ISL_700485|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0676/2020|EPI_ISL_700510|2020-10-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1344/2020|EPI_ISL_700529|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0812/2020|EPI_ISL_700551|2020-10-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1148/2020|EPI_ISL_700467|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1145/2020|EPI_ISL_700554|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3556-KRISP/2020|EPI_ISL_696473|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1396-KRISP/2020|EPI_ISL_696472|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7063-KRISP/2020|EPI_ISL_696492|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7013-KRISP/2020|EPI_ISL_696491|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3553-KRISP/2020|EPI_ISL_696481|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7042-KRISP/2020|EPI_ISL_696496|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7065-KRISP/2020|EPI_ISL_696503|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7025-KRISP/2020|EPI_ISL_696500|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1395-KRISP/2020|EPI_ISL_696474|2020-11-18|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7000-KRISP/2020|EPI_ISL_696490|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0660/2020|EPI_ISL_700438|2020-10-22|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352416/2020|EPI_ISL_736928|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0666/2020|EPI_ISL_700587|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1378/2020|EPI_ISL_700542|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7043-KRISP/2020|EPI_ISL_696494|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7067-KRISP/2020|EPI_ISL_696495|2020-11-25|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1385/2020|EPI_ISL_700470|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1100/2020|EPI_ISL_700431|2020-11-03|Africa', 'hCoV-19/South_Africa/N00390/2020|EPI_ISL_712081|2020-10-08|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1131/2020|EPI_ISL_700487|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2101-KRISP/2020|EPI_ISL_696455|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1363/2020|EPI_ISL_700490|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2090-KRISP/2020|EPI_ISL_696452|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3558-KRISP/2020|EPI_ISL_696459|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7058-KRISP/2020|EPI_ISL_696515|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1383/2020|EPI_ISL_700456|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1380/2020|EPI_ISL_700524|2020-11-13|Africa', 'hCoV-19/South_Africa/KRISP-WC-SA04352428/2020|EPI_ISL_736929|2020-11-24|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1388/2020|EPI_ISL_700475|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7034-KRISP/2020|EPI_ISL_696521|2020-11-24|Africa', 'hCoV-19/England/ALDP-C8FEC7/2020|EPI_ISL_777292|2020-12-11|Europe', 'hCoV-19/South_Africa/NHLS-UCT-GS-1350/2020|EPI_ISL_700440|2020-11-06|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1107/2020|EPI_ISL_700504|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-0671/2020|EPI_ISL_700483|2020-10-23|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1365/2020|EPI_ISL_700502|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1269/2020|EPI_ISL_700461|2020-11-05|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1454-KRISP/2020|EPI_ISL_696470|2020-11-19|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1030/2020|EPI_ISL_700498|2020-10-27|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (892, 'A', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.012195121951219513, 'FC': 12195.121951219513, 'epi_start': 869, 'epi_stop': 911, 'epi_seq': 'MIAQYTSALLAGTITSGWTFGAGAALQIPFAMQMAYRFNGIGV', '#linear': 10, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-0807/2020|EPI_ISL_700492|2020-10-15|Africa'], 'annotations': []}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (1182, 'E', 'D'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.012195121951219513, 'FC': 12195.121951219513, 'epi_start': 1155, 'epi_stop': 1207, 'epi_seq': 'YFKNHTSPDVDLGDISGINASVVNIQKEIDRLNEVAKNLNESLIDLQELGKYE', '#linear': 31, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 11, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1912-KRISP/2020|EPI_ISL_696461|2020-11-19|Africa'], 'annotations': ['heptapeptide repeat sequence 2']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (1227, 'I', 'V'), '# cluster': 2, '% lineage': 0.0, '% cluster': 0.024390243902439025, 'FC': 24390.243902439026, 'epi_start': 1202, 'epi_stop': 1244, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCL', '#linear': 11, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037942', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037935', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037968', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037251', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 14, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1389/2020|EPI_ISL_700520|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1390/2020|EPI_ISL_700589|2020-11-12|Africa'], 'annotations': ['TM domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (247, 'S', 'N'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.012195121951219513, 'FC': 12195.121951219513, 'epi_start': 233, 'epi_stop': 282, 'epi_seq': 'INITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 9, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1037008', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 11, '#pubs non-linear': 5, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-0659/2020|EPI_ISL_700581|2020-10-22|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 1, '% lineage': 0.991014799154334, '% cluster': 0.012195121951219513, 'FC': 0.012305678639660443, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (1219, 'G', 'V'), '# cluster': 1, '% lineage': 0.0010570824524312897, '% cluster': 0.012195121951219513, 'FC': 11.525682070614858, 'epi_start': 1202, 'epi_stop': 1244, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCL', '#linear': 16, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037085', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-1628-KRISP/2020|EPI_ISL_696475|2020-11-19|Africa'], 'annotations': ['TM domain']}, {'cluster': 'c39', 'lineage': 'B.1.351', 'mutation': (1223, 'G', 'S'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.012195121951219513, 'FC': 12195.121951219513, 'epi_start': 1202, 'epi_stop': 1244, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCL', '#linear': 13, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037942', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1037935', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037968', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037251', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 15, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-7037-KRISP/2020|EPI_ISL_696512|2020-11-24|Africa'], 'annotations': ['TM domain']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'H'), '# cluster': 5, '% lineage': 0.0015856236786469344, '% cluster': 1.0, 'FC': 630.2691769057648, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 5, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 5, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 5, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 5, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': []}, {'cluster': 'c4', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 5, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/N00335/2020|EPI_ISL_712076|2020-11-05|Africa', 'hCoV-19/SouthAfrica/KRISP-K006879/2020|EPI_ISL_825126|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-BH02956605/2020|EPI_ISL_736933|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007732/2020|EPI_ISL_825454|2020-12-15|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3560-KRISP/2020|EPI_ISL_696453|2020-11-20|Africa'], 'annotations': []}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 12, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 12, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 12, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 12, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 12, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 12, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 12, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 12, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 12, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': []}, {'cluster': 'c45', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 12, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K004630/2020|EPI_ISL_660646|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7019-KRISP/2020|EPI_ISL_696486|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1387/2020|EPI_ISL_700420|2020-11-12|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1381/2020|EPI_ISL_700436|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1326/2020|EPI_ISL_700579|2020-11-04|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1392-KRISP/2020|EPI_ISL_696460|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1373/2020|EPI_ISL_700541|2020-11-13|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7017-KRISP/2020|EPI_ISL_696482|2020-11-20|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-1312/2020|EPI_ISL_700500|2020-11-02|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-7021-KRISP/2020|EPI_ISL_696479|2020-11-20|Africa', 'hCoV-19/South_Africa/KRISP-K004599/2020|EPI_ISL_660629|2020-11-06|Africa', 'hCoV-19/Sweden/20-13194/2020|EPI_ISL_766709|2020-12-24|Europe'], 'annotations': []}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 7, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 7, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 7, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 7, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 7, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 7, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 7, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 6, '% lineage': 0.9191331923890064, '% cluster': 0.8571428571428571, 'FC': 0.9325546413576217, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': []}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 7, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-BH02956385/2020|EPI_ISL_736932|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007725/2020|EPI_ISL_825450|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K007740/2020|EPI_ISL_825481|2020-12-14|Africa', 'hCoV-19/South_Africa/KRISP-K007729/2020|EPI_ISL_825451|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-BH02956196/2020|EPI_ISL_736931|2020-11-25|Africa', 'hCoV-19/South_Africa/KRISP-K007721/2020|EPI_ISL_825455|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': []}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (76, 'T', 'I'), '# cluster': 1, '% lineage': 0.0005285412262156448, '% cluster': 0.14285714285714285, 'FC': 269.77529941921307, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 12, '#non-linear': 1, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038547'], '#pubs linear': 6, '#pubs non-linear': 1, 'sequences': ['hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c46', 'lineage': 'B.1.351', 'mutation': (938, 'L', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.14285714285714285, 'FC': 142857.14285714287, 'epi_start': 906, 'epi_stop': 955, 'epi_seq': 'FNGIGVTQNVLYENQKLIANQFNSAIGKIQDSLSSTASALGKLQDVVNQN', '#linear': 30, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/SouthAfrica/KRISP-K007633/2020|EPI_ISL_825137|2020-12-17|Africa'], 'annotations': ['heptapeptide repeat sequence 1']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 7, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 7, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 7, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 7, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 7, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 7, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 7, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 7, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': []}, {'cluster': 'c47', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 7, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-K007804/2021|EPI_ISL_860577|2021-01-03|Africa', 'hCoV-19/South_Africa/KRISP-K007780/2021|EPI_ISL_860557|2021-01-05|Africa', 'hCoV-19/South_Africa/KRISP-K007731/2020|EPI_ISL_825478|2020-12-15|Africa', 'hCoV-19/SouthAfrica/KRISP-K007628/2020|EPI_ISL_825133|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007769/2020|EPI_ISL_825442|2020-12-18|Africa', 'hCoV-19/South_Africa/KRISP-K007726/2020|EPI_ISL_825447|2020-12-15|Africa', 'hCoV-19/South_Africa/KRISP-K004349-CS1/2020|EPI_ISL_660222|2020-11-09|Africa'], 'annotations': []}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (80, 'D', 'A'), '# cluster': 5, '% lineage': 0.9978858350951374, '% cluster': 1.0, 'FC': 1.0021176398270262, 'epi_start': 63, 'epi_stop': 93, 'epi_seq': 'TWFHAIHVSGTNGTKRFDNPVLPFNDGVYFA', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (215, 'D', 'G'), '# cluster': 5, '% lineage': 0.991014799154334, '% cluster': 1.0, 'FC': 1.0090656484521563, 'epi_start': 186, 'epi_stop': 233, 'epi_seq': 'FKNLREFVFKNIDGYFKIYSKHTPINLVRDLPQGFSALEPLVDLPIGI', '#linear': 26, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038242'], '#pubs linear': 14, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (241, 'L', '-'), '# cluster': 5, '% lineage': 0.903276955602537, '% cluster': 1.0, 'FC': 1.1070789382133697, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (242, 'L', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (243, 'A', '-'), '# cluster': 5, '% lineage': 0.9022198731501057, '% cluster': 1.0, 'FC': 1.1083760415656294, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (417, 'K', 'N'), '# cluster': 5, '% lineage': 0.9920718816067653, '% cluster': 1.0, 'FC': 1.007990459713399, 'epi_start': 401, 'epi_stop': 435, 'epi_seq': 'VIRGDEVRQIAPGQTGKIADYNYKLPDDFTGCVIA', '#linear': 22, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037842', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038141', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037012', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 32, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['Receptor binding domain']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (484, 'E', 'K'), '# cluster': 5, '% lineage': 0.9133192389006343, '% cluster': 1.0, 'FC': 1.0949062085864891, 'epi_start': 466, 'epi_stop': 513, 'epi_seq': 'RDISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVL', '#linear': 24, '#non-linear': 59, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037844', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038381', 'http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1038392', 'http://www.iedb.org/reference/1038094', 'http://www.iedb.org/reference/1037909', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1038480', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038140', 'http://www.iedb.org/reference/1038157', 'http://www.iedb.org/reference/1038243', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1036941', 'http://www.iedb.org/reference/1037938', 'http://www.iedb.org/reference/1037013', 'http://www.iedb.org/reference/1037156', 'http://www.iedb.org/reference/1038033', 'http://www.iedb.org/reference/1038249', 'http://www.iedb.org/reference/1037473', 'http://www.iedb.org/reference/1037865', 'http://www.iedb.org/reference/1038391', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037735', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038001', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038415', 'http://www.iedb.org/reference/1038078', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 15, '#pubs non-linear': 39, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (501, 'N', 'Y'), '# cluster': 5, '% lineage': 0.9191331923890064, '% cluster': 1.0, 'FC': 1.0879804149172254, 'epi_start': 467, 'epi_stop': 541, 'epi_seq': 'DISTEIYQAGSTPCNGVEGFNCYFPLQSYGFQPTNGVGYQPYRVVVLSFELLHAPATVCGPKKSTNLVKNKCVNF', '#linear': 16, '#non-linear': 53, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038086'], 'pubs non-linear': ['http://www.iedb.org/reference/1038159', 'http://www.iedb.org/reference/1038379', 'http://www.iedb.org/reference/1038548', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038064', 'http://www.iedb.org/reference/1036880', 'http://www.iedb.org/reference/1037444', 'http://www.iedb.org/reference/1038474', 'http://www.iedb.org/reference/1038081', 'http://www.iedb.org/reference/1036942', 'http://www.iedb.org/reference/1037443', 'http://www.iedb.org/reference/1037522', 'http://www.iedb.org/reference/1038079', 'http://www.iedb.org/reference/1037105', 'http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1037575', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1037106', 'http://www.iedb.org/reference/1038378', 'http://www.iedb.org/reference/1038008', 'http://www.iedb.org/reference/1038035', 'http://www.iedb.org/reference/1037720', 'http://www.iedb.org/reference/1038500', 'http://www.iedb.org/reference/1037545', 'http://www.iedb.org/reference/1038390', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1036918', 'http://www.iedb.org/reference/1038077', 'http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038007'], '#pubs linear': 9, '#pubs non-linear': 30, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': ['Receptor binding domain', 'Receptor binding motif']}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.9973572938689218, '% cluster': 1.0, 'FC': 1.0026487032266314, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': []}, {'cluster': 'c49', 'lineage': 'B.1.351', 'mutation': (701, 'A', 'V'), '# cluster': 5, '% lineage': 0.936046511627907, '% cluster': 1.0, 'FC': 1.0683218400536865, 'epi_start': 684, 'epi_stop': 726, 'epi_seq': 'ARSVASQSIIAYTMSLGAENSVAYSNNSIAIPTNFTISVTTEI', '#linear': 14, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 7, '#pubs non-linear': 2, 'sequences': ['hCoV-19/South_Africa/KRISP-GI00293257/2020|EPI_ISL_736956|2020-11-24|Africa', 'hCoV-19/South_Africa/KRISP-K005330/2020|EPI_ISL_678618|2020-11-17|Africa', 'hCoV-19/South_Africa/KRISP-K007768/2020|EPI_ISL_825443|2020-12-18|Africa', 'hCoV-19/Japan/IC-0527/2020|EPI_ISL_779210|2020-12-00|Asia', 'hCoV-19/Netherlands/LI-RIVM-10606/2021|EPI_ISL_904753|2021-01-13|Europe'], 'annotations': []}, {'cluster': 'c65', 'lineage': 'B.1.140', 'mutation': (614, 'D', 'G'), '# cluster': 7, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-0408/2020|EPI_ISL_495533|2020-06-23|Africa', 'hCoV-19/South_Africa/KRISP-0405/2020|EPI_ISL_495530|2020-06-23|Africa', 'hCoV-19/South_Africa/KRISP-0402/2020|EPI_ISL_495527|2020-06-23|Africa', 'hCoV-19/South_Africa/KRISP-0549/2020|EPI_ISL_498088|2020-07-15|Africa', 'hCoV-19/South_Africa/KRISP-K002313/2020|EPI_ISL_515689|2020-07-22|Africa', 'hCoV-19/South_Africa/KRISP-0383/2020|EPI_ISL_495524|2020-06-25|Africa', 'hCoV-19/South_Africa/KRISP-K002209/2020|EPI_ISL_515606|2020-07-24|Africa'], 'annotations': []}, {'cluster': 'c65', 'lineage': 'B.1.140', 'mutation': (865, 'L', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.14285714285714285, 'FC': 142857.14285714287, 'epi_start': 832, 'epi_stop': 882, 'epi_seq': 'GFIKQYGDCLGDIAARDLICAQKFNGLTVLPPLLTDEMIAQYTSALLAGTI', '#linear': 20, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037697', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037251', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 13, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-0383/2020|EPI_ISL_495524|2020-06-25|Africa'], 'annotations': []}, {'cluster': 'c65', 'lineage': 'B.1.140', 'mutation': (13, 'S', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.14285714285714285, 'FC': 142857.14285714287, 'epi_start': 1, 'epi_stop': 27, 'epi_seq': 'MFVFLVLLPLVSSQCVNLTTRTQLPPA', '#linear': 10, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037968'], 'pubs non-linear': [], '#pubs linear': 5, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K002209/2020|EPI_ISL_515606|2020-07-24|Africa'], 'annotations': ['signal peptide at N-terminus']}, {'cluster': 'c72', 'lineage': 'B.1.106', 'mutation': (614, 'D', 'G'), '# cluster': 11, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K001122/2020|EPI_ISL_515801|2020-07-16|Africa', 'hCoV-19/South_Africa/KRISP-K000637/2020|EPI_ISL_509287|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-K002205/2020|EPI_ISL_515603|2020-07-16|Africa', 'hCoV-19/South_Africa/KRISP-0373/2020|EPI_ISL_487324|2020-06-19|Africa', 'hCoV-19/South_Africa/KRISP-K002201/2020|EPI_ISL_515599|2020-07-01|Africa', 'hCoV-19/South_Africa/KRISP-K001345/2020|EPI_ISL_515830|2020-07-13|Africa', 'hCoV-19/South_Africa/KRISP-0487/2020|EPI_ISL_495562|2020-07-03|Africa', 'hCoV-19/South_Africa/KRISP-K001406/2020|EPI_ISL_515889|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K001401/2020|EPI_ISL_515884|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K001400/2020|EPI_ISL_515883|2020-07-17|Africa', 'hCoV-19/South_Africa/KRISP-K002244/2020|EPI_ISL_515635|2020-07-20|Africa'], 'annotations': []}, {'cluster': 'c72', 'lineage': 'B.1.106', 'mutation': (769, 'G', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.09090909090909091, 'FC': 90909.09090909091, 'epi_start': 753, 'epi_stop': 788, 'epi_seq': 'LLQYGSFCTQLNRALTGIAVEQDKNTQEVFAQVKQI', '#linear': 25, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K001345/2020|EPI_ISL_515830|2020-07-13|Africa'], 'annotations': []}, {'cluster': 'c73', 'lineage': 'B.1.106', 'mutation': (614, 'D', 'G'), '# cluster': 17, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-0196/2020|EPI_ISL_482712|2020-06-08|Africa', 'hCoV-19/South_Africa/KRISP-0163/2020|EPI_ISL_467513|2020-06-01|Africa', 'hCoV-19/South_Africa/KRISP-0191/2020|EPI_ISL_482710|2020-06-04|Africa', 'hCoV-19/South_Africa/KRISP-0193/2020|EPI_ISL_482848|2020-06-03|Africa', 'hCoV-19/South_Africa/KRISP-0194/2020|EPI_ISL_482849|2020-06-06|Africa', 'hCoV-19/South_Africa/KRISP-0195/2020|EPI_ISL_482850|2020-06-07|Africa', 'hCoV-19/South_Africa/KRISP-0162/2020|EPI_ISL_467512|2020-06-01|Africa', 'hCoV-19/South_Africa/KRISP-0158/2020|EPI_ISL_467508|2020-05-28|Africa', 'hCoV-19/South_Africa/KRISP-0173/2020|EPI_ISL_467523|2020-06-02|Africa', 'hCoV-19/South_Africa/KRISP-0171/2020|EPI_ISL_467521|2020-06-02|Africa', 'hCoV-19/South_Africa/KRISP-0174/2020|EPI_ISL_467524|2020-06-04|Africa', 'hCoV-19/South_Africa/KRISP-0167/2020|EPI_ISL_467517|2020-06-02|Africa', 'hCoV-19/South_Africa/KRISP-0161/2020|EPI_ISL_467511|2020-06-01|Africa', 'hCoV-19/South_Africa/KRISP-0164/2020|EPI_ISL_467514|2020-06-01|Africa', 'hCoV-19/South_Africa/KRISP-0168/2020|EPI_ISL_467518|2020-05-28|Africa', 'hCoV-19/South_Africa/KRISP-0172/2020|EPI_ISL_467522|2020-06-02|Africa', 'hCoV-19/South_Africa/KRISP-0192/2020|EPI_ISL_482711|2020-06-04|Africa'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (176, 'L', 'F'), '# cluster': 1, '% lineage': 0.0003860893439341074, '% cluster': 0.043478260869565216, 'FC': 112.32099656291838, 'epi_start': 161, 'epi_stop': 193, 'epi_seq': 'SSANNCTFEYVSQPFLMDLEGKQGNFKNLREFV', '#linear': 35, '#non-linear': 3, 'pubs linear': ['http://www.iedb.org/reference/1037960', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1036944'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 14, '#pubs non-linear': 1, 'sequences': ['hCoV-19/England/QEUH-AF7600/2020|EPI_ISL_662854|2020-10-29|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (222, 'A', 'V'), '# cluster': 23, '% lineage': 0.9940656637876795, '% cluster': 1.0, 'FC': 1.0059687508176893, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/QEUH-AF7600/2020|EPI_ISL_662854|2020-10-29|Europe', 'hCoV-19/England/QEUH-9F4895/2020|EPI_ISL_588386|2020-09-25|Europe', 'hCoV-19/Iceland/6013/2020|EPI_ISL_829692|2020-10-12|Europe', 'hCoV-19/England/QEUH-A63A4F/2020|EPI_ISL_628659|2020-10-12|Europe', 'hCoV-19/Spain/RI-IBV-99010996/2020|EPI_ISL_732819|2020-09-06|Europe', 'hCoV-19/Netherlands/ZH-EMC-750/2020|EPI_ISL_632591|2020-09-24|Europe', 'hCoV-19/England/MILK-A47768/2020|EPI_ISL_598365|2020-10-05|Europe', 'hCoV-19/England/CAMC-A65096/2020|EPI_ISL_608368|2020-10-11|Europe', 'hCoV-19/England/MILK-ACC024/2020|EPI_ISL_629208|2020-10-21|Europe', 'hCoV-19/England/ALDP-BBA592/2020|EPI_ISL_702517|2020-11-20|Europe', 'hCoV-19/Wales/PHWC-49460B/2020|EPI_ISL_726143|2020-11-20|Europe', 'hCoV-19/England/204691035/2020|EPI_ISL_693433|2020-11-11|Europe', 'hCoV-19/Scotland/CVR4004/2020|EPI_ISL_535104|2020-08-29|Europe', 'hCoV-19/England/MILK-ABBF76/2020|EPI_ISL_631130|2020-10-20|Europe', 'hCoV-19/England/ALDP-B747AD/2020|EPI_ISL_662045|2020-11-12|Europe', 'hCoV-19/England/CAMC-A80D70/2020|EPI_ISL_610912|2020-10-13|Europe', 'hCoV-19/England/QEUH-A0C87B/2020|EPI_ISL_599280|2020-10-03|Europe', 'hCoV-19/England/QEUH-AE1AFE/2020|EPI_ISL_633553|2020-10-24|Europe', 'hCoV-19/Wales/PHWC-4A49A5/2020|EPI_ISL_763409|2020-12-09|Europe', 'hCoV-19/England/QEUH-A5E081/2020|EPI_ISL_597315|2020-10-12|Europe', 'hCoV-19/England/TFCI-26FEA47/2020|EPI_ISL_868794|2020-10-30|Europe', 'hCoV-19/Ireland/KY-NVRL-72IRL47632/2020|EPI_ISL_578219|2020-08-19|Europe', 'hCoV-19/Luxembourg/LNS0642518/2020|EPI_ISL_739809|2020-11-03|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (245, 'H', 'Y'), '# cluster': 1, '% lineage': 0.001930446719670537, '% cluster': 0.043478260869565216, 'FC': 22.51072236514071, 'epi_start': 231, 'epi_stop': 282, 'epi_seq': 'IGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 9, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1037008', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038547', 'http://www.iedb.org/reference/1038086'], '#pubs linear': 11, '#pubs non-linear': 5, 'sequences': ['hCoV-19/England/QEUH-AF7600/2020|EPI_ISL_662854|2020-10-29|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (614, 'D', 'G'), '# cluster': 23, '% lineage': 0.9998284047360293, '% cluster': 1.0, 'FC': 1.0001706243716804, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/England/QEUH-AF7600/2020|EPI_ISL_662854|2020-10-29|Europe', 'hCoV-19/England/QEUH-9F4895/2020|EPI_ISL_588386|2020-09-25|Europe', 'hCoV-19/Iceland/6013/2020|EPI_ISL_829692|2020-10-12|Europe', 'hCoV-19/England/QEUH-A63A4F/2020|EPI_ISL_628659|2020-10-12|Europe', 'hCoV-19/Spain/RI-IBV-99010996/2020|EPI_ISL_732819|2020-09-06|Europe', 'hCoV-19/Netherlands/ZH-EMC-750/2020|EPI_ISL_632591|2020-09-24|Europe', 'hCoV-19/England/MILK-A47768/2020|EPI_ISL_598365|2020-10-05|Europe', 'hCoV-19/England/CAMC-A65096/2020|EPI_ISL_608368|2020-10-11|Europe', 'hCoV-19/England/MILK-ACC024/2020|EPI_ISL_629208|2020-10-21|Europe', 'hCoV-19/England/ALDP-BBA592/2020|EPI_ISL_702517|2020-11-20|Europe', 'hCoV-19/Wales/PHWC-49460B/2020|EPI_ISL_726143|2020-11-20|Europe', 'hCoV-19/England/204691035/2020|EPI_ISL_693433|2020-11-11|Europe', 'hCoV-19/Scotland/CVR4004/2020|EPI_ISL_535104|2020-08-29|Europe', 'hCoV-19/England/MILK-ABBF76/2020|EPI_ISL_631130|2020-10-20|Europe', 'hCoV-19/England/ALDP-B747AD/2020|EPI_ISL_662045|2020-11-12|Europe', 'hCoV-19/England/CAMC-A80D70/2020|EPI_ISL_610912|2020-10-13|Europe', 'hCoV-19/England/QEUH-A0C87B/2020|EPI_ISL_599280|2020-10-03|Europe', 'hCoV-19/England/QEUH-AE1AFE/2020|EPI_ISL_633553|2020-10-24|Europe', 'hCoV-19/Wales/PHWC-4A49A5/2020|EPI_ISL_763409|2020-12-09|Europe', 'hCoV-19/England/QEUH-A5E081/2020|EPI_ISL_597315|2020-10-12|Europe', 'hCoV-19/England/TFCI-26FEA47/2020|EPI_ISL_868794|2020-10-30|Europe', 'hCoV-19/Ireland/KY-NVRL-72IRL47632/2020|EPI_ISL_578219|2020-08-19|Europe', 'hCoV-19/Luxembourg/LNS0642518/2020|EPI_ISL_739809|2020-11-03|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (1163, 'D', 'Y'), '# cluster': 1, '% lineage': 0.029457186981639308, '% cluster': 0.043478260869565216, 'FC': 1.4759313224763064, 'epi_start': 1135, 'epi_stop': 1184, 'epi_seq': 'NTVYDPLQPELDSFKEELDKYFKNHTSPDVDLGDISGINASVVNIQKEID', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/QEUH-A63A4F/2020|EPI_ISL_628659|2020-10-12|Europe'], 'annotations': ['heptapeptide repeat sequence 2']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (1167, 'G', 'V'), '# cluster': 2, '% lineage': 0.029957673168220556, '% cluster': 0.08695652173913043, 'FC': 2.902549163337842, 'epi_start': 1153, 'epi_stop': 1207, 'epi_seq': 'DKYFKNHTSPDVDLGDISGINASVVNIQKEIDRLNEVAKNLNESLIDLQELGKYE', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/QEUH-A63A4F/2020|EPI_ISL_628659|2020-10-12|Europe', 'hCoV-19/Spain/RI-IBV-99010996/2020|EPI_ISL_732819|2020-09-06|Europe'], 'annotations': ['heptapeptide repeat sequence 2']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (678, 'T', 'I'), '# cluster': 1, '% lineage': 0.0005147857919121432, '% cluster': 0.043478260869565216, 'FC': 84.29518911015509, 'epi_start': 647, 'epi_stop': 695, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAY', '#linear': 27, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Netherlands/ZH-EMC-750/2020|EPI_ISL_632591|2020-09-24|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (1045, 'K', 'N'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.043478260869565216, 'FC': 43478.260869565216, 'epi_start': 1026, 'epi_stop': 1059, 'epi_seq': 'ATKMSECVLGQSKRVDFCGKGYHLMSFPQSAPHG', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Netherlands/ZH-EMC-750/2020|EPI_ISL_632591|2020-09-24|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (262, 'A', 'S'), '# cluster': 2, '% lineage': 0.024666819195790196, '% cluster': 0.08695652173913043, 'FC': 3.525099687530157, 'epi_start': 240, 'epi_stop': 282, 'epi_seq': 'TLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 15, '#non-linear': 4, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 8, '#pubs non-linear': 1, 'sequences': ['hCoV-19/England/MILK-ACC024/2020|EPI_ISL_629208|2020-10-21|Europe', 'hCoV-19/England/ALDP-BBA592/2020|EPI_ISL_702517|2020-11-20|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (272, 'P', 'L'), '# cluster': 2, '% lineage': 0.02438082708917234, '% cluster': 0.08695652173913043, 'FC': 3.566448134551275, 'epi_start': 240, 'epi_stop': 285, 'epi_seq': 'TLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNENGTI', '#linear': 19, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037942', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037137', 'http://www.iedb.org/reference/1037949', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037363', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037085', 'http://www.iedb.org/reference/1038382', 'http://www.iedb.org/reference/1037882', 'http://www.iedb.org/reference/1037935', 'http://www.iedb.org/reference/1038013', 'http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1037576', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037971', 'http://www.iedb.org/reference/1037941', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 23, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/MILK-ACC024/2020|EPI_ISL_629208|2020-10-21|Europe', 'hCoV-19/England/ALDP-BBA592/2020|EPI_ISL_702517|2020-11-20|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (18, 'L', 'F'), '# cluster': 5, '% lineage': 0.7797431790882572, '% cluster': 0.21739130434782608, 'FC': 0.27879823944568377, 'epi_start': 1, 'epi_stop': 34, 'epi_seq': 'MFVFLVLLPLVSSQCVNLTTRTQLPPAYTNSFTR', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 4, 'sequences': ['hCoV-19/England/MILK-ABBF76/2020|EPI_ISL_631130|2020-10-20|Europe', 'hCoV-19/England/ALDP-B747AD/2020|EPI_ISL_662045|2020-11-12|Europe', 'hCoV-19/England/CAMC-A80D70/2020|EPI_ISL_610912|2020-10-13|Europe', 'hCoV-19/England/QEUH-A0C87B/2020|EPI_ISL_599280|2020-10-03|Europe', 'hCoV-19/England/QEUH-AE1AFE/2020|EPI_ISL_633553|2020-10-24|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (561, 'P', 'S'), '# cluster': 1, '% lineage': 0.0013155636904421438, '% cluster': 0.043478260869565216, 'FC': 33.02404675535586, 'epi_start': 544, 'epi_stop': 578, 'epi_seq': 'NGLTGTGVLTESNKKFLPFQQFGRDIADTTDAVRD', '#linear': 34, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037435', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1036856', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/ALDP-B747AD/2020|EPI_ISL_662045|2020-11-12|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (241, 'L', '-'), '# cluster': 1, '% lineage': 7.149802665446433e-05, '% cluster': 0.043478260869565216, 'FC': 599.7164733433181, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 24, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Luxembourg/LNS0642518/2020|EPI_ISL_739809|2020-11-03|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (242, 'L', '-'), '# cluster': 1, '% lineage': 0.00018589486930160727, '% cluster': 0.043478260869565216, 'FC': 232.63485526400862, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 10, '#pubs non-linear': 2, 'sequences': ['hCoV-19/Luxembourg/LNS0642518/2020|EPI_ISL_739809|2020-11-03|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177', 'mutation': (243, 'A', '-'), '# cluster': 1, '% lineage': 0.00020019447463250013, '% cluster': 0.043478260869565216, 'FC': 216.10067050291607, 'epi_start': 224, 'epi_stop': 282, 'epi_seq': 'EPLVDLPIGINITRFQTLLALHRSYLTPGDSSSGWTAGAAAYYVGYLQPRTFLLKYNEN', '#linear': 21, '#non-linear': 10, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038478', 'http://www.iedb.org/reference/1038477', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086', 'http://www.iedb.org/reference/1038065', 'http://www.iedb.org/reference/1038085'], '#pubs linear': 11, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Luxembourg/LNS0642518/2020|EPI_ISL_739809|2020-11-03|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177.1', 'mutation': (222, 'A', 'V'), '# cluster': 1, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Denmark/DCGC-7915/2020|EPI_ISL_618851|2020-10-26|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177.1', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Denmark/DCGC-7915/2020|EPI_ISL_618851|2020-10-26|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177.12', 'mutation': (222, 'A', 'V'), '# cluster': 2, '% lineage': 0.5, '% cluster': 1.0, 'FC': 1.999996000008, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Denmark/DCGC-6140/2020|EPI_ISL_621174|2020-09-21|Europe', 'hCoV-19/Denmark/DCGC-17348/2020|EPI_ISL_750925|2020-12-14|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177.12', 'mutation': (614, 'D', 'G'), '# cluster': 2, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Denmark/DCGC-6140/2020|EPI_ISL_621174|2020-09-21|Europe', 'hCoV-19/Denmark/DCGC-17348/2020|EPI_ISL_750925|2020-12-14|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177.12', 'mutation': (1073, 'K', 'T'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.5, 'FC': 500000.0, 'epi_start': 1054, 'epi_stop': 1096, 'epi_seq': 'QSAPHGVVFLHVTYVPAQEKNFTTAPAICHDGKAHFPREGVFV', '#linear': 19, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Denmark/DCGC-17348/2020|EPI_ISL_750925|2020-12-14|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177.14', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Spain/MD-ISCIII-2014825/2020|EPI_ISL_691725|2020-08-26|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177.16', 'mutation': (222, 'A', 'V'), '# cluster': 3, '% lineage': 0.9951154529307282, '% cluster': 1.0, 'FC': 1.0049075131406873, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/QEUH-AAB3D7/2020|EPI_ISL_652789|2020-10-21|Europe', 'hCoV-19/England/MILK-D19FFB/2020|EPI_ISL_799847|2020-12-21|Europe', 'hCoV-19/England/MILK-BAA999/2020|EPI_ISL_681646|2020-11-17|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177.16', 'mutation': (614, 'D', 'G'), '# cluster': 3, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/England/QEUH-AAB3D7/2020|EPI_ISL_652789|2020-10-21|Europe', 'hCoV-19/England/MILK-D19FFB/2020|EPI_ISL_799847|2020-12-21|Europe', 'hCoV-19/England/MILK-BAA999/2020|EPI_ISL_681646|2020-11-17|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177.18', 'mutation': (222, 'A', 'V'), '# cluster': 4, '% lineage': 0.9958711808422791, '% cluster': 1.0, 'FC': 1.0041449286737076, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/EXET-13DD8A/2020|EPI_ISL_724290|2020-12-02|Europe', 'hCoV-19/England/CAMC-A3EC83/2020|EPI_ISL_609797|2020-10-05|Europe', 'hCoV-19/England/CAMB-1B6439/2020|EPI_ISL_576908|2020-09-22|Europe', 'hCoV-19/England/MILK-B3DAC5/2020|EPI_ISL_741385|2020-11-02|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177.18', 'mutation': (583, 'E', 'D'), '# cluster': 4, '% lineage': 0.9991742361684558, '% cluster': 1.0, 'FC': 1.0008254446284186, 'epi_start': 564, 'epi_stop': 595, 'epi_seq': 'QFGRDIADTTDAVRDPQTLEILDITPCSFGGV', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1037971', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 8, '#pubs non-linear': 0, 'sequences': ['hCoV-19/England/EXET-13DD8A/2020|EPI_ISL_724290|2020-12-02|Europe', 'hCoV-19/England/CAMC-A3EC83/2020|EPI_ISL_609797|2020-10-05|Europe', 'hCoV-19/England/CAMB-1B6439/2020|EPI_ISL_576908|2020-09-22|Europe', 'hCoV-19/England/MILK-B3DAC5/2020|EPI_ISL_741385|2020-11-02|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177.18', 'mutation': (614, 'D', 'G'), '# cluster': 4, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/England/EXET-13DD8A/2020|EPI_ISL_724290|2020-12-02|Europe', 'hCoV-19/England/CAMC-A3EC83/2020|EPI_ISL_609797|2020-10-05|Europe', 'hCoV-19/England/CAMB-1B6439/2020|EPI_ISL_576908|2020-09-22|Europe', 'hCoV-19/England/MILK-B3DAC5/2020|EPI_ISL_741385|2020-11-02|Europe'], 'annotations': []}, {'cluster': 'c78', 'lineage': 'B.1.177.24', 'mutation': (222, 'A', 'V'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 204, 'epi_stop': 235, 'epi_seq': 'YSKHTPINLVRDLPQGFSALEPLVDLPIGINI', '#linear': 23, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1037960'], 'pubs non-linear': [], '#pubs linear': 11, '#pubs non-linear': 0, 'sequences': ['hCoV-19/Denmark/DCGC-3939/2020|EPI_ISL_615850|2020-09-14|Europe'], 'annotations': ['N-terminal domain']}, {'cluster': 'c78', 'lineage': 'B.1.177.24', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/Denmark/DCGC-3939/2020|EPI_ISL_615850|2020-09-14|Europe'], 'annotations': []}, {'cluster': 'c93', 'lineage': 'B.1', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 0.9960946785750671, '% cluster': 1.0, 'FC': 1.0039196249004092, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-3554/2020|EPI_ISL_640092|2020-10-09|Africa'], 'annotations': []}, {'cluster': 'c93', 'lineage': 'B.1.157', 'mutation': (614, 'D', 'G'), '# cluster': 1, '% lineage': 1.0, '% cluster': 1.0, 'FC': 0.9999990000010001, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-3471/2020|EPI_ISL_640086|2020-09-28|Africa'], 'annotations': []}, {'cluster': 'c93', 'lineage': 'B.1.157', 'mutation': (675, 'Q', 'H'), '# cluster': 1, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 647, 'epi_stop': 695, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAY', '#linear': 21, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/NHLS-UCT-GS-3471/2020|EPI_ISL_640086|2020-09-28|Africa'], 'annotations': []}, {'cluster': 'c93', 'lineage': 'B.1.237', 'mutation': (614, 'D', 'G'), '# cluster': 10, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/Tygerberg_323_CC2/2020|EPI_ISL_660132|2020-10-11|Africa', 'hCoV-19/South_Africa/Tygerberg_318_CC2/2020|EPI_ISL_660127|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_337_CC2/2020|EPI_ISL_660144|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_365_CC2/2020|EPI_ISL_660157|2020-10-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3514/2020|EPI_ISL_640137|2020-10-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3472/2020|EPI_ISL_640136|2020-09-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3461/2020|EPI_ISL_640131|2020-09-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3555/2020|EPI_ISL_640093|2020-10-10|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2025/2020|EPI_ISL_640120|2020-09-15|Africa', 'hCoV-19/South_Africa/KRISP-K004733/2020|EPI_ISL_660261|2020-10-20|Africa'], 'annotations': []}, {'cluster': 'c93', 'lineage': 'B.1.237', 'mutation': (675, 'Q', 'H'), '# cluster': 10, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 647, 'epi_stop': 695, 'epi_seq': 'AGCLIGAEHVNNSYECDIPIGAGICASYQTQTNSPRRARSVASQSIIAY', '#linear': 21, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037915', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 9, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/Tygerberg_323_CC2/2020|EPI_ISL_660132|2020-10-11|Africa', 'hCoV-19/South_Africa/Tygerberg_318_CC2/2020|EPI_ISL_660127|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_337_CC2/2020|EPI_ISL_660144|2020-10-09|Africa', 'hCoV-19/South_Africa/Tygerberg_365_CC2/2020|EPI_ISL_660157|2020-10-16|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3514/2020|EPI_ISL_640137|2020-10-07|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3472/2020|EPI_ISL_640136|2020-09-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3461/2020|EPI_ISL_640131|2020-09-28|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-3555/2020|EPI_ISL_640093|2020-10-10|Africa', 'hCoV-19/South_Africa/NHLS-UCT-GS-2025/2020|EPI_ISL_640120|2020-09-15|Africa', 'hCoV-19/South_Africa/KRISP-K004733/2020|EPI_ISL_660261|2020-10-20|Africa'], 'annotations': []}, {'cluster': 'c97', 'lineage': 'B.1', 'mutation': (18, 'L', 'F'), '# cluster': 5, '% lineage': 0.018541786939246782, '% cluster': 1.0, 'FC': 53.92932590318705, 'epi_start': 1, 'epi_stop': 34, 'epi_seq': 'MFVFLVLLPLVSSQCVNLTTRTQLPPAYTNSFTR', '#linear': 13, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038063', 'http://www.iedb.org/reference/1038085', 'http://www.iedb.org/reference/1038547'], '#pubs linear': 7, '#pubs non-linear': 4, 'sequences': ['hCoV-19/South_Africa/KRISP-K003384/2020|EPI_ISL_602772|2020-09-10|Africa', 'hCoV-19/South_Africa/L00175/2020|EPI_ISL_622961|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K004055/2020|EPI_ISL_635034|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004049/2020|EPI_ISL_635028|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K004326/2020|EPI_ISL_660202|2020-10-25|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c97', 'lineage': 'B.1', 'mutation': (614, 'D', 'G'), '# cluster': 5, '% lineage': 0.9960946785750671, '% cluster': 1.0, 'FC': 1.0039196249004092, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K003384/2020|EPI_ISL_602772|2020-09-10|Africa', 'hCoV-19/South_Africa/L00175/2020|EPI_ISL_622961|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K004055/2020|EPI_ISL_635034|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004049/2020|EPI_ISL_635028|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K004326/2020|EPI_ISL_660202|2020-10-25|Africa'], 'annotations': []}, {'cluster': 'c97', 'lineage': 'B.1', 'mutation': (1251, 'G', 'V'), '# cluster': 5, '% lineage': 0.00010187795021564166, '% cluster': 1.0, 'FC': 9720.255875082152, 'epi_start': 1236, 'epi_stop': 1270, 'epi_seq': 'CMTSCCSCLKGCCSCGSCCKFDEDDSEPVLKGVKL', '#linear': 12, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038514', 'http://www.iedb.org/reference/1037435'], 'pubs non-linear': [], '#pubs linear': 6, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K003384/2020|EPI_ISL_602772|2020-09-10|Africa', 'hCoV-19/South_Africa/L00175/2020|EPI_ISL_622961|2020-07-27|Africa', 'hCoV-19/South_Africa/KRISP-K004055/2020|EPI_ISL_635034|2020-10-19|Africa', 'hCoV-19/South_Africa/KRISP-K004049/2020|EPI_ISL_635028|2020-10-20|Africa', 'hCoV-19/South_Africa/KRISP-K004326/2020|EPI_ISL_660202|2020-10-25|Africa'], 'annotations': ['cytoplasm domain']}, {'cluster': 'c97', 'lineage': 'B.1', 'mutation': (179, 'L', 'F'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.2, 'FC': 200000.00000000003, 'epi_start': 164, 'epi_stop': 194, 'epi_seq': 'NNCTFEYVSQPFLMDLEGKQGNFKNLREFVF', '#linear': 30, '#non-linear': 2, 'pubs linear': ['http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1038060', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1036944'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 10, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K004055/2020|EPI_ISL_635034|2020-10-19|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c99', 'lineage': 'B.1.417', 'mutation': (614, 'D', 'G'), '# cluster': 19, '% lineage': 0.0, '% cluster': 1.0, 'FC': 1000000.0, 'epi_start': 601, 'epi_stop': 652, 'epi_seq': 'GTNTSNQVAVLYQDVNCTEVPVAIHADQLTPTWRVYSTGSNVFQTRAGCLIG', '#linear': 12, '#non-linear': 6, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': ['http://www.iedb.org/reference/1038242', 'http://www.iedb.org/reference/1038245', 'http://www.iedb.org/reference/1038548'], '#pubs linear': 6, '#pubs non-linear': 3, 'sequences': ['hCoV-19/South_Africa/KRISP-K002608/2020|EPI_ISL_535472|2020-08-01|Africa', 'hCoV-19/South_Africa/KRISP-K002613/2020|EPI_ISL_535477|2020-07-28|Africa', 'hCoV-19/South_Africa/KRISP-K004334/2020|EPI_ISL_660210|2020-10-24|Africa', 'hCoV-19/South_Africa/KRISP-K005312/2020|EPI_ISL_678605|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004317/2020|EPI_ISL_660194|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004318/2020|EPI_ISL_660195|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004643/2020|EPI_ISL_660658|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K005310/2020|EPI_ISL_678603|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K003694/2020|EPI_ISL_602875|2020-10-05|Africa', 'hCoV-19/South_Africa/KRISP-K004053/2020|EPI_ISL_635032|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004061/2020|EPI_ISL_635040|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004059/2020|EPI_ISL_635038|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004057/2020|EPI_ISL_635036|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004341/2020|EPI_ISL_660217|2020-10-28|Africa', 'hCoV-19/South_Africa/KRISP-K004613/2020|EPI_ISL_660636|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K004058/2020|EPI_ISL_635037|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004316/2020|EPI_ISL_660193|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K002591/2020|EPI_ISL_535456|2020-07-28|Africa', 'hCoV-19/South_Africa/KRISP-K001321/2020|EPI_ISL_515806|2020-07-18|Africa'], 'annotations': []}, {'cluster': 'c99', 'lineage': 'B.1.417', 'mutation': (939, 'S', 'F'), '# cluster': 15, '% lineage': 0.0, '% cluster': 0.7894736842105263, 'FC': 789473.6842105264, 'epi_start': 906, 'epi_stop': 968, 'epi_seq': 'FNGIGVTQNVLYENQKLIANQFNSAIGKIQDSLSSTASALGKLQDVVNQNAQALNTLVKQLSS', '#linear': 31, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1038006', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037486', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806'], 'pubs non-linear': [], '#pubs linear': 10, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K004334/2020|EPI_ISL_660210|2020-10-24|Africa', 'hCoV-19/South_Africa/KRISP-K005312/2020|EPI_ISL_678605|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004317/2020|EPI_ISL_660194|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004318/2020|EPI_ISL_660195|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004643/2020|EPI_ISL_660658|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K005310/2020|EPI_ISL_678603|2020-10-30|Africa', 'hCoV-19/South_Africa/KRISP-K003694/2020|EPI_ISL_602875|2020-10-05|Africa', 'hCoV-19/South_Africa/KRISP-K004053/2020|EPI_ISL_635032|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004061/2020|EPI_ISL_635040|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004059/2020|EPI_ISL_635038|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004057/2020|EPI_ISL_635036|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004341/2020|EPI_ISL_660217|2020-10-28|Africa', 'hCoV-19/South_Africa/KRISP-K004613/2020|EPI_ISL_660636|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K004058/2020|EPI_ISL_635037|2020-10-18|Africa', 'hCoV-19/South_Africa/KRISP-K004316/2020|EPI_ISL_660193|2020-10-26|Africa'], 'annotations': ['heptapeptide repeat sequence 1']}, {'cluster': 'c99', 'lineage': 'B.1.417', 'mutation': (175, 'F', 'S'), '# cluster': 5, '% lineage': 0.0, '% cluster': 0.2631578947368421, 'FC': 263157.8947368421, 'epi_start': 161, 'epi_stop': 193, 'epi_seq': 'SSANNCTFEYVSQPFLMDLEGKQGNFKNLREFV', '#linear': 34, '#non-linear': 3, 'pubs linear': ['http://www.iedb.org/reference/1037960', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037798', 'http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037393', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892', 'http://www.iedb.org/reference/1037946', 'http://www.iedb.org/reference/1037806', 'http://www.iedb.org/reference/1036944'], 'pubs non-linear': ['http://www.iedb.org/reference/1038086'], '#pubs linear': 13, '#pubs non-linear': 1, 'sequences': ['hCoV-19/South_Africa/KRISP-K005312/2020|EPI_ISL_678605|2020-11-16|Africa', 'hCoV-19/South_Africa/KRISP-K004317/2020|EPI_ISL_660194|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004318/2020|EPI_ISL_660195|2020-10-26|Africa', 'hCoV-19/South_Africa/KRISP-K004643/2020|EPI_ISL_660658|2020-11-04|Africa', 'hCoV-19/South_Africa/KRISP-K005310/2020|EPI_ISL_678603|2020-10-30|Africa'], 'annotations': ['N-terminal domain']}, {'cluster': 'c99', 'lineage': 'B.1.417', 'mutation': (1237, 'M', 'I'), '# cluster': 1, '% lineage': 0.0, '% cluster': 0.05263157894736842, 'FC': 52631.57894736842, 'epi_start': 1202, 'epi_stop': 1255, 'epi_seq': 'ELGKYEQYIKWPWYIWLGFIAGLIAIVMVTIMLCCMTSCCSCLKGCCSCGSCCK', '#linear': 14, '#non-linear': 0, 'pubs linear': ['http://www.iedb.org/reference/1037809', 'http://www.iedb.org/reference/1036945', 'http://www.iedb.org/reference/1037823', 'http://www.iedb.org/reference/1037940', 'http://www.iedb.org/reference/1037412', 'http://www.iedb.org/reference/1037195', 'http://www.iedb.org/reference/1036892'], 'pubs non-linear': [], '#pubs linear': 7, '#pubs non-linear': 0, 'sequences': ['hCoV-19/South_Africa/KRISP-K005310/2020|EPI_ISL_678603|2020-10-30|Africa'], 'annotations': ['TM domain', 'cytoplasm domain']}] + + cont = itertools.count() + + def html_metadata(k, v): + k = k[0].upper() + k[1:] + + if k == "Mut": + k = "Mutations" + v = ", ".join([f"{x[1]}{x[0]}{x[2]}" for x in v]) + if k == "Fs_flag": + k == "Frameshift" + v = "Has frameshift" if v else "" + k = k.replace("_", " ") + return f"{k}: {v}" + + def html_def_itemlist(items): + + res = "" + return res + + def html_template(mutation_name, cluster_name, lineage_name, num_cluster, perc_lineage, perc_cluster, fc, + epi_start, epi_stop, epi_seq, epi_linear, epi_nonlinear, sequences, list_linear, + list_nonlinear, + domains): + res = "" + mut_name_s = f'{mutation_name[1]}{mutation_name[0]}{mutation_name[2]}' + res += f"""
+ {mutation_name[1]}{mutation_name[0]}{mutation_name[2]} + in cluster {cluster_name} vs + lineage {lineage_name} +
""" + res += "" + return res + + js = ''' + + + ''' + + def select_pair_html(count, freq): + + res = mut_table + res = res[res["# cluster"] >= count] + res = res[res["% lineage"] <= freq / 100] + res = res.reset_index(drop=True) + + html_all = "" + for x in res.T.to_dict().values(): + html_all += html_template(x['mutation'], x['cluster'], x['lineage'], + x['# cluster'], x['% lineage'], x['% cluster'], x['FC'], + x['epi_start'], x['epi_stop'], x['epi_seq'], x['#linear'], + x['#non-linear'], x["sequences"], x["pubs linear"], + x["pubs non-linear"], x["annotations"]) + html_all += "
" + + html = html_all + # + js + return html + + # html_to = {} + html_to = select_pair_html(0, 5) + results = {'table': list_dict, 'html': html_to} + + return results diff --git a/backend/apis/epitope.py b/backend/apis/epitope.py deleted file mode 100644 index c688011..0000000 --- a/backend/apis/epitope.py +++ /dev/null @@ -1,108 +0,0 @@ - -from flask_restplus import Namespace, Resource, fields, inputs - - -is_gisaid = False -epitope_id = 'iedb_epitope_id' - -api = Namespace('epitope', description='epitope') - -query = api.model('epitope', { -}) - -table_parser = api.parser() -table_parser.add_argument('page', type=int) -table_parser.add_argument('num_elems', type=int) -table_parser.add_argument('order_col', type=str, default='accession_id') -table_parser.add_argument('order_dir', type=str, default='asc') - - -class ColumnEpi: - - def __init__(self, text, field, description, type, is_numerical=False, is_percentage=False): - self.text = text - self.field = field - self.description = description - self.type = type - self.is_numerical = is_numerical - self.is_percentage = is_percentage - - def __str__(self): - return str(self.__dict__) - - def __repr__(self): - return str(self.__dict__) - - -columns_epi_sel = [ - ColumnEpi('Protein Name', 'product', 'Name of the protein where the epitopes must be located', 'str', False, False), - ColumnEpi('Assay', 'cell_type', 'Assay type of the epitopes', 'str', False, False), - ColumnEpi('HLA restriction', 'mhc_allele', 'HLA restriction that must be related to the epitopes', 'str', False, False), - ColumnEpi('Is Linear', 'is_linear', 'Information related to the type of the epitopes (linear or conformational)', 'str', False, False), - ColumnEpi('Response Frequency', 'response_frequency', 'info resp freq', 'num', False, True), - ColumnEpi('Position Range', 'position_range', 'Range in which the epitopes must have at least a part included', 'num', True, False), - ColumnEpi('Epitope IEDB ID', 'iedb_epitope_id', 'IEDB ID of the epitope', 'num', False, False), - #ColumnEpi('Assay Type', 'assay_type', 'Assay type', 'str', False, False), -] - -columns_epi_amino = [ - ColumnEpi('Variant Position Range', 'variant_position_range', - 'Range of positions within the amino acid sequence of the gene, based on the reference sequence. ' - 'Insertions and deletions have arbitrary lengths. Substitutions only involve one amino acid residue. ' - 'Please search for one single substitution at a time.', 'num', - True, False), - ColumnEpi('Variant Type', 'variant_aa_type', 'Type of amino acid change that must appear in the epitopes (SUB = substitution, INS = insertion, DEL = deletion)', 'str', False, False), - ColumnEpi('Original Aminoacid', 'sequence_aa_original', 'Affected amino acid sequence from the corresponding reference sequence of the chosen Virus', 'str', False, False), - ColumnEpi('Alternative Aminoacid', 'sequence_aa_alternative', 'Changed amino acid sequence (in the target sequence) with respect to the reference one', 'str', False, False), -] - -columns_user_new_epi_sel = [ - ColumnEpi('Epitope Name', 'epitope_name', 'Name of the custom epitope (Names must be unique)', 'str', False, False), - ColumnEpi('Protein Name', 'product', 'Name of the protein where the custom epitope will be located', 'str', False, False), - ColumnEpi('Position Range', 'position_range', 'Range within the chosen protein in which the custom epitope is located. More than one range could be selected to create a conformational epitope (Add one fragment range at a time)', 'num', True, False), -] - -columns_user_new_epi_amino = [ - ColumnEpi('Protein Name', 'product', 'Protein produced by the sub-sequence within which the amino acid change occurs', 'str', False, False), - ColumnEpi('Position Range', 'position_range', 'Range of positions within the amino acid sequence of the gene, based on the reference sequence', 'num', True, False), - ColumnEpi('Variant Type', 'variant_aa_type', 'Type of amino acid change (SUB = substitution, INS = insertion, DEL = deletion)', 'str', False, False), - ColumnEpi('Original Aminoacid', 'sequence_aa_original', 'Affected amino acid sequence from the corresponding reference sequence of the chosen Virus', 'str', False, False), - ColumnEpi('Alternative Aminoacid', 'sequence_aa_alternative', 'Changed amino acid sequence (in the target sequence) with respect to the reference one', 'str', False, False), -] - -columns_dict_epi_sel = {x.field: x for x in columns_epi_sel} - -columns_dict_user_new_epi_sel = {x.field: x for x in columns_user_new_epi_sel} - -columns_dict_epi_amino = {x.field: x for x in columns_epi_amino} - -columns_dict_user_new_epi_amino = {x.field: x for x in columns_user_new_epi_amino} - -columns_dict_epi_all = {x.field: x for x in columns_epi_sel + columns_epi_amino} - - -field = api.model('Field', { - 'text': fields.String(attribute='text', required=True, description='Name of the Field '), - 'field': fields.String(attribute='field', description='Field in table '), - 'description': fields.String(attribute='description', description='Field description '), - 'is_numerical': fields.Boolean(attribute='is_numerical', - description='True if field is numerical, False otherwise '), - 'is_percentage': fields.Boolean(attribute='is_percentage', description='True if field is a percentage' - ', False otherwise '), -}) - -field_list = api.model('Fields', { - 'fields': fields.List(fields.Nested(field, required=True, description='Fields', skip_none=True)) -}) - - -######################################################################################################## - - -@api.route('') -class FieldList(Resource): - @api.doc('get_field_list') - def get(self): - res = {'fields': "hello"} - return res - diff --git a/backend/apis/ref_cov2.fasta b/backend/apis/ref_cov2.fasta new file mode 100644 index 0000000..b15a9f0 --- /dev/null +++ b/backend/apis/ref_cov2.fasta @@ -0,0 +1,429 @@ +>NC_045512.2 Severe acute respiratory syndrome coronavirus 2 isolate Wuhan-Hu-1, complete genome +ATTAAAGGTTTATACCTTCCCAGGTAACAAACCAACCAACTTTCGATCTCTTGTAGATCTGTTCTCTAAA +CGAACTTTAAAATCTGTGTGGCTGTCACTCGGCTGCATGCTTAGTGCACTCACGCAGTATAATTAATAAC +TAATTACTGTCGTTGACAGGACACGAGTAACTCGTCTATCTTCTGCAGGCTGCTTACGGTTTCGTCCGTG +TTGCAGCCGATCATCAGCACATCTAGGTTTCGTCCGGGTGTGACCGAAAGGTAAGATGGAGAGCCTTGTC +CCTGGTTTCAACGAGAAAACACACGTCCAACTCAGTTTGCCTGTTTTACAGGTTCGCGACGTGCTCGTAC +GTGGCTTTGGAGACTCCGTGGAGGAGGTCTTATCAGAGGCACGTCAACATCTTAAAGATGGCACTTGTGG +CTTAGTAGAAGTTGAAAAAGGCGTTTTGCCTCAACTTGAACAGCCCTATGTGTTCATCAAACGTTCGGAT +GCTCGAACTGCACCTCATGGTCATGTTATGGTTGAGCTGGTAGCAGAACTCGAAGGCATTCAGTACGGTC +GTAGTGGTGAGACACTTGGTGTCCTTGTCCCTCATGTGGGCGAAATACCAGTGGCTTACCGCAAGGTTCT +TCTTCGTAAGAACGGTAATAAAGGAGCTGGTGGCCATAGTTACGGCGCCGATCTAAAGTCATTTGACTTA +GGCGACGAGCTTGGCACTGATCCTTATGAAGATTTTCAAGAAAACTGGAACACTAAACATAGCAGTGGTG +TTACCCGTGAACTCATGCGTGAGCTTAACGGAGGGGCATACACTCGCTATGTCGATAACAACTTCTGTGG +CCCTGATGGCTACCCTCTTGAGTGCATTAAAGACCTTCTAGCACGTGCTGGTAAAGCTTCATGCACTTTG +TCCGAACAACTGGACTTTATTGACACTAAGAGGGGTGTATACTGCTGCCGTGAACATGAGCATGAAATTG +CTTGGTACACGGAACGTTCTGAAAAGAGCTATGAATTGCAGACACCTTTTGAAATTAAATTGGCAAAGAA +ATTTGACACCTTCAATGGGGAATGTCCAAATTTTGTATTTCCCTTAAATTCCATAATCAAGACTATTCAA +CCAAGGGTTGAAAAGAAAAAGCTTGATGGCTTTATGGGTAGAATTCGATCTGTCTATCCAGTTGCGTCAC +CAAATGAATGCAACCAAATGTGCCTTTCAACTCTCATGAAGTGTGATCATTGTGGTGAAACTTCATGGCA +GACGGGCGATTTTGTTAAAGCCACTTGCGAATTTTGTGGCACTGAGAATTTGACTAAAGAAGGTGCCACT +ACTTGTGGTTACTTACCCCAAAATGCTGTTGTTAAAATTTATTGTCCAGCATGTCACAATTCAGAAGTAG +GACCTGAGCATAGTCTTGCCGAATACCATAATGAATCTGGCTTGAAAACCATTCTTCGTAAGGGTGGTCG +CACTATTGCCTTTGGAGGCTGTGTGTTCTCTTATGTTGGTTGCCATAACAAGTGTGCCTATTGGGTTCCA +CGTGCTAGCGCTAACATAGGTTGTAACCATACAGGTGTTGTTGGAGAAGGTTCCGAAGGTCTTAATGACA +ACCTTCTTGAAATACTCCAAAAAGAGAAAGTCAACATCAATATTGTTGGTGACTTTAAACTTAATGAAGA +GATCGCCATTATTTTGGCATCTTTTTCTGCTTCCACAAGTGCTTTTGTGGAAACTGTGAAAGGTTTGGAT +TATAAAGCATTCAAACAAATTGTTGAATCCTGTGGTAATTTTAAAGTTACAAAAGGAAAAGCTAAAAAAG +GTGCCTGGAATATTGGTGAACAGAAATCAATACTGAGTCCTCTTTATGCATTTGCATCAGAGGCTGCTCG +TGTTGTACGATCAATTTTCTCCCGCACTCTTGAAACTGCTCAAAATTCTGTGCGTGTTTTACAGAAGGCC +GCTATAACAATACTAGATGGAATTTCACAGTATTCACTGAGACTCATTGATGCTATGATGTTCACATCTG +ATTTGGCTACTAACAATCTAGTTGTAATGGCCTACATTACAGGTGGTGTTGTTCAGTTGACTTCGCAGTG +GCTAACTAACATCTTTGGCACTGTTTATGAAAAACTCAAACCCGTCCTTGATTGGCTTGAAGAGAAGTTT +AAGGAAGGTGTAGAGTTTCTTAGAGACGGTTGGGAAATTGTTAAATTTATCTCAACCTGTGCTTGTGAAA +TTGTCGGTGGACAAATTGTCACCTGTGCAAAGGAAATTAAGGAGAGTGTTCAGACATTCTTTAAGCTTGT +AAATAAATTTTTGGCTTTGTGTGCTGACTCTATCATTATTGGTGGAGCTAAACTTAAAGCCTTGAATTTA +GGTGAAACATTTGTCACGCACTCAAAGGGATTGTACAGAAAGTGTGTTAAATCCAGAGAAGAAACTGGCC +TACTCATGCCTCTAAAAGCCCCAAAAGAAATTATCTTCTTAGAGGGAGAAACACTTCCCACAGAAGTGTT +AACAGAGGAAGTTGTCTTGAAAACTGGTGATTTACAACCATTAGAACAACCTACTAGTGAAGCTGTTGAA +GCTCCATTGGTTGGTACACCAGTTTGTATTAACGGGCTTATGTTGCTCGAAATCAAAGACACAGAAAAGT +ACTGTGCCCTTGCACCTAATATGATGGTAACAAACAATACCTTCACACTCAAAGGCGGTGCACCAACAAA +GGTTACTTTTGGTGATGACACTGTGATAGAAGTGCAAGGTTACAAGAGTGTGAATATCACTTTTGAACTT +GATGAAAGGATTGATAAAGTACTTAATGAGAAGTGCTCTGCCTATACAGTTGAACTCGGTACAGAAGTAA +ATGAGTTCGCCTGTGTTGTGGCAGATGCTGTCATAAAAACTTTGCAACCAGTATCTGAATTACTTACACC +ACTGGGCATTGATTTAGATGAGTGGAGTATGGCTACATACTACTTATTTGATGAGTCTGGTGAGTTTAAA +TTGGCTTCACATATGTATTGTTCTTTCTACCCTCCAGATGAGGATGAAGAAGAAGGTGATTGTGAAGAAG +AAGAGTTTGAGCCATCAACTCAATATGAGTATGGTACTGAAGATGATTACCAAGGTAAACCTTTGGAATT +TGGTGCCACTTCTGCTGCTCTTCAACCTGAAGAAGAGCAAGAAGAAGATTGGTTAGATGATGATAGTCAA +CAAACTGTTGGTCAACAAGACGGCAGTGAGGACAATCAGACAACTACTATTCAAACAATTGTTGAGGTTC +AACCTCAATTAGAGATGGAACTTACACCAGTTGTTCAGACTATTGAAGTGAATAGTTTTAGTGGTTATTT +AAAACTTACTGACAATGTATACATTAAAAATGCAGACATTGTGGAAGAAGCTAAAAAGGTAAAACCAACA +GTGGTTGTTAATGCAGCCAATGTTTACCTTAAACATGGAGGAGGTGTTGCAGGAGCCTTAAATAAGGCTA +CTAACAATGCCATGCAAGTTGAATCTGATGATTACATAGCTACTAATGGACCACTTAAAGTGGGTGGTAG +TTGTGTTTTAAGCGGACACAATCTTGCTAAACACTGTCTTCATGTTGTCGGCCCAAATGTTAACAAAGGT +GAAGACATTCAACTTCTTAAGAGTGCTTATGAAAATTTTAATCAGCACGAAGTTCTACTTGCACCATTAT +TATCAGCTGGTATTTTTGGTGCTGACCCTATACATTCTTTAAGAGTTTGTGTAGATACTGTTCGCACAAA +TGTCTACTTAGCTGTCTTTGATAAAAATCTCTATGACAAACTTGTTTCAAGCTTTTTGGAAATGAAGAGT +GAAAAGCAAGTTGAACAAAAGATCGCTGAGATTCCTAAAGAGGAAGTTAAGCCATTTATAACTGAAAGTA +AACCTTCAGTTGAACAGAGAAAACAAGATGATAAGAAAATCAAAGCTTGTGTTGAAGAAGTTACAACAAC +TCTGGAAGAAACTAAGTTCCTCACAGAAAACTTGTTACTTTATATTGACATTAATGGCAATCTTCATCCA +GATTCTGCCACTCTTGTTAGTGACATTGACATCACTTTCTTAAAGAAAGATGCTCCATATATAGTGGGTG +ATGTTGTTCAAGAGGGTGTTTTAACTGCTGTGGTTATACCTACTAAAAAGGCTGGTGGCACTACTGAAAT +GCTAGCGAAAGCTTTGAGAAAAGTGCCAACAGACAATTATATAACCACTTACCCGGGTCAGGGTTTAAAT +GGTTACACTGTAGAGGAGGCAAAGACAGTGCTTAAAAAGTGTAAAAGTGCCTTTTACATTCTACCATCTA +TTATCTCTAATGAGAAGCAAGAAATTCTTGGAACTGTTTCTTGGAATTTGCGAGAAATGCTTGCACATGC +AGAAGAAACACGCAAATTAATGCCTGTCTGTGTGGAAACTAAAGCCATAGTTTCAACTATACAGCGTAAA +TATAAGGGTATTAAAATACAAGAGGGTGTGGTTGATTATGGTGCTAGATTTTACTTTTACACCAGTAAAA +CAACTGTAGCGTCACTTATCAACACACTTAACGATCTAAATGAAACTCTTGTTACAATGCCACTTGGCTA +TGTAACACATGGCTTAAATTTGGAAGAAGCTGCTCGGTATATGAGATCTCTCAAAGTGCCAGCTACAGTT +TCTGTTTCTTCACCTGATGCTGTTACAGCGTATAATGGTTATCTTACTTCTTCTTCTAAAACACCTGAAG +AACATTTTATTGAAACCATCTCACTTGCTGGTTCCTATAAAGATTGGTCCTATTCTGGACAATCTACACA +ACTAGGTATAGAATTTCTTAAGAGAGGTGATAAAAGTGTATATTACACTAGTAATCCTACCACATTCCAC +CTAGATGGTGAAGTTATCACCTTTGACAATCTTAAGACACTTCTTTCTTTGAGAGAAGTGAGGACTATTA +AGGTGTTTACAACAGTAGACAACATTAACCTCCACACGCAAGTTGTGGACATGTCAATGACATATGGACA +ACAGTTTGGTCCAACTTATTTGGATGGAGCTGATGTTACTAAAATAAAACCTCATAATTCACATGAAGGT +AAAACATTTTATGTTTTACCTAATGATGACACTCTACGTGTTGAGGCTTTTGAGTACTACCACACAACTG +ATCCTAGTTTTCTGGGTAGGTACATGTCAGCATTAAATCACACTAAAAAGTGGAAATACCCACAAGTTAA +TGGTTTAACTTCTATTAAATGGGCAGATAACAACTGTTATCTTGCCACTGCATTGTTAACACTCCAACAA +ATAGAGTTGAAGTTTAATCCACCTGCTCTACAAGATGCTTATTACAGAGCAAGGGCTGGTGAAGCTGCTA +ACTTTTGTGCACTTATCTTAGCCTACTGTAATAAGACAGTAGGTGAGTTAGGTGATGTTAGAGAAACAAT +GAGTTACTTGTTTCAACATGCCAATTTAGATTCTTGCAAAAGAGTCTTGAACGTGGTGTGTAAAACTTGT +GGACAACAGCAGACAACCCTTAAGGGTGTAGAAGCTGTTATGTACATGGGCACACTTTCTTATGAACAAT +TTAAGAAAGGTGTTCAGATACCTTGTACGTGTGGTAAACAAGCTACAAAATATCTAGTACAACAGGAGTC +ACCTTTTGTTATGATGTCAGCACCACCTGCTCAGTATGAACTTAAGCATGGTACATTTACTTGTGCTAGT +GAGTACACTGGTAATTACCAGTGTGGTCACTATAAACATATAACTTCTAAAGAAACTTTGTATTGCATAG +ACGGTGCTTTACTTACAAAGTCCTCAGAATACAAAGGTCCTATTACGGATGTTTTCTACAAAGAAAACAG +TTACACAACAACCATAAAACCAGTTACTTATAAATTGGATGGTGTTGTTTGTACAGAAATTGACCCTAAG +TTGGACAATTATTATAAGAAAGACAATTCTTATTTCACAGAGCAACCAATTGATCTTGTACCAAACCAAC +CATATCCAAACGCAAGCTTCGATAATTTTAAGTTTGTATGTGATAATATCAAATTTGCTGATGATTTAAA +CCAGTTAACTGGTTATAAGAAACCTGCTTCAAGAGAGCTTAAAGTTACATTTTTCCCTGACTTAAATGGT +GATGTGGTGGCTATTGATTATAAACACTACACACCCTCTTTTAAGAAAGGAGCTAAATTGTTACATAAAC +CTATTGTTTGGCATGTTAACAATGCAACTAATAAAGCCACGTATAAACCAAATACCTGGTGTATACGTTG +TCTTTGGAGCACAAAACCAGTTGAAACATCAAATTCGTTTGATGTACTGAAGTCAGAGGACGCGCAGGGA +ATGGATAATCTTGCCTGCGAAGATCTAAAACCAGTCTCTGAAGAAGTAGTGGAAAATCCTACCATACAGA +AAGACGTTCTTGAGTGTAATGTGAAAACTACCGAAGTTGTAGGAGACATTATACTTAAACCAGCAAATAA +TAGTTTAAAAATTACAGAAGAGGTTGGCCACACAGATCTAATGGCTGCTTATGTAGACAATTCTAGTCTT +ACTATTAAGAAACCTAATGAATTATCTAGAGTATTAGGTTTGAAAACCCTTGCTACTCATGGTTTAGCTG +CTGTTAATAGTGTCCCTTGGGATACTATAGCTAATTATGCTAAGCCTTTTCTTAACAAAGTTGTTAGTAC +AACTACTAACATAGTTACACGGTGTTTAAACCGTGTTTGTACTAATTATATGCCTTATTTCTTTACTTTA +TTGCTACAATTGTGTACTTTTACTAGAAGTACAAATTCTAGAATTAAAGCATCTATGCCGACTACTATAG +CAAAGAATACTGTTAAGAGTGTCGGTAAATTTTGTCTAGAGGCTTCATTTAATTATTTGAAGTCACCTAA +TTTTTCTAAACTGATAAATATTATAATTTGGTTTTTACTATTAAGTGTTTGCCTAGGTTCTTTAATCTAC +TCAACCGCTGCTTTAGGTGTTTTAATGTCTAATTTAGGCATGCCTTCTTACTGTACTGGTTACAGAGAAG +GCTATTTGAACTCTACTAATGTCACTATTGCAACCTACTGTACTGGTTCTATACCTTGTAGTGTTTGTCT +TAGTGGTTTAGATTCTTTAGACACCTATCCTTCTTTAGAAACTATACAAATTACCATTTCATCTTTTAAA +TGGGATTTAACTGCTTTTGGCTTAGTTGCAGAGTGGTTTTTGGCATATATTCTTTTCACTAGGTTTTTCT +ATGTACTTGGATTGGCTGCAATCATGCAATTGTTTTTCAGCTATTTTGCAGTACATTTTATTAGTAATTC +TTGGCTTATGTGGTTAATAATTAATCTTGTACAAATGGCCCCGATTTCAGCTATGGTTAGAATGTACATC +TTCTTTGCATCATTTTATTATGTATGGAAAAGTTATGTGCATGTTGTAGACGGTTGTAATTCATCAACTT +GTATGATGTGTTACAAACGTAATAGAGCAACAAGAGTCGAATGTACAACTATTGTTAATGGTGTTAGAAG +GTCCTTTTATGTCTATGCTAATGGAGGTAAAGGCTTTTGCAAACTACACAATTGGAATTGTGTTAATTGT +GATACATTCTGTGCTGGTAGTACATTTATTAGTGATGAAGTTGCGAGAGACTTGTCACTACAGTTTAAAA +GACCAATAAATCCTACTGACCAGTCTTCTTACATCGTTGATAGTGTTACAGTGAAGAATGGTTCCATCCA +TCTTTACTTTGATAAAGCTGGTCAAAAGACTTATGAAAGACATTCTCTCTCTCATTTTGTTAACTTAGAC +AACCTGAGAGCTAATAACACTAAAGGTTCATTGCCTATTAATGTTATAGTTTTTGATGGTAAATCAAAAT +GTGAAGAATCATCTGCAAAATCAGCGTCTGTTTACTACAGTCAGCTTATGTGTCAACCTATACTGTTACT +AGATCAGGCATTAGTGTCTGATGTTGGTGATAGTGCGGAAGTTGCAGTTAAAATGTTTGATGCTTACGTT +AATACGTTTTCATCAACTTTTAACGTACCAATGGAAAAACTCAAAACACTAGTTGCAACTGCAGAAGCTG +AACTTGCAAAGAATGTGTCCTTAGACAATGTCTTATCTACTTTTATTTCAGCAGCTCGGCAAGGGTTTGT +TGATTCAGATGTAGAAACTAAAGATGTTGTTGAATGTCTTAAATTGTCACATCAATCTGACATAGAAGTT +ACTGGCGATAGTTGTAATAACTATATGCTCACCTATAACAAAGTTGAAAACATGACACCCCGTGACCTTG +GTGCTTGTATTGACTGTAGTGCGCGTCATATTAATGCGCAGGTAGCAAAAAGTCACAACATTGCTTTGAT +ATGGAACGTTAAAGATTTCATGTCATTGTCTGAACAACTACGAAAACAAATACGTAGTGCTGCTAAAAAG +AATAACTTACCTTTTAAGTTGACATGTGCAACTACTAGACAAGTTGTTAATGTTGTAACAACAAAGATAG +CACTTAAGGGTGGTAAAATTGTTAATAATTGGTTGAAGCAGTTAATTAAAGTTACACTTGTGTTCCTTTT +TGTTGCTGCTATTTTCTATTTAATAACACCTGTTCATGTCATGTCTAAACATACTGACTTTTCAAGTGAA +ATCATAGGATACAAGGCTATTGATGGTGGTGTCACTCGTGACATAGCATCTACAGATACTTGTTTTGCTA +ACAAACATGCTGATTTTGACACATGGTTTAGCCAGCGTGGTGGTAGTTATACTAATGACAAAGCTTGCCC +ATTGATTGCTGCAGTCATAACAAGAGAAGTGGGTTTTGTCGTGCCTGGTTTGCCTGGCACGATATTACGC +ACAACTAATGGTGACTTTTTGCATTTCTTACCTAGAGTTTTTAGTGCAGTTGGTAACATCTGTTACACAC +CATCAAAACTTATAGAGTACACTGACTTTGCAACATCAGCTTGTGTTTTGGCTGCTGAATGTACAATTTT +TAAAGATGCTTCTGGTAAGCCAGTACCATATTGTTATGATACCAATGTACTAGAAGGTTCTGTTGCTTAT +GAAAGTTTACGCCCTGACACACGTTATGTGCTCATGGATGGCTCTATTATTCAATTTCCTAACACCTACC +TTGAAGGTTCTGTTAGAGTGGTAACAACTTTTGATTCTGAGTACTGTAGGCACGGCACTTGTGAAAGATC +AGAAGCTGGTGTTTGTGTATCTACTAGTGGTAGATGGGTACTTAACAATGATTATTACAGATCTTTACCA +GGAGTTTTCTGTGGTGTAGATGCTGTAAATTTACTTACTAATATGTTTACACCACTAATTCAACCTATTG +GTGCTTTGGACATATCAGCATCTATAGTAGCTGGTGGTATTGTAGCTATCGTAGTAACATGCCTTGCCTA +CTATTTTATGAGGTTTAGAAGAGCTTTTGGTGAATACAGTCATGTAGTTGCCTTTAATACTTTACTATTC +CTTATGTCATTCACTGTACTCTGTTTAACACCAGTTTACTCATTCTTACCTGGTGTTTATTCTGTTATTT +ACTTGTACTTGACATTTTATCTTACTAATGATGTTTCTTTTTTAGCACATATTCAGTGGATGGTTATGTT +CACACCTTTAGTACCTTTCTGGATAACAATTGCTTATATCATTTGTATTTCCACAAAGCATTTCTATTGG +TTCTTTAGTAATTACCTAAAGAGACGTGTAGTCTTTAATGGTGTTTCCTTTAGTACTTTTGAAGAAGCTG +CGCTGTGCACCTTTTTGTTAAATAAAGAAATGTATCTAAAGTTGCGTAGTGATGTGCTATTACCTCTTAC +GCAATATAATAGATACTTAGCTCTTTATAATAAGTACAAGTATTTTAGTGGAGCAATGGATACAACTAGC +TACAGAGAAGCTGCTTGTTGTCATCTCGCAAAGGCTCTCAATGACTTCAGTAACTCAGGTTCTGATGTTC +TTTACCAACCACCACAAACCTCTATCACCTCAGCTGTTTTGCAGAGTGGTTTTAGAAAAATGGCATTCCC +ATCTGGTAAAGTTGAGGGTTGTATGGTACAAGTAACTTGTGGTACAACTACACTTAACGGTCTTTGGCTT +GATGACGTAGTTTACTGTCCAAGACATGTGATCTGCACCTCTGAAGACATGCTTAACCCTAATTATGAAG +ATTTACTCATTCGTAAGTCTAATCATAATTTCTTGGTACAGGCTGGTAATGTTCAACTCAGGGTTATTGG +ACATTCTATGCAAAATTGTGTACTTAAGCTTAAGGTTGATACAGCCAATCCTAAGACACCTAAGTATAAG +TTTGTTCGCATTCAACCAGGACAGACTTTTTCAGTGTTAGCTTGTTACAATGGTTCACCATCTGGTGTTT +ACCAATGTGCTATGAGGCCCAATTTCACTATTAAGGGTTCATTCCTTAATGGTTCATGTGGTAGTGTTGG +TTTTAACATAGATTATGACTGTGTCTCTTTTTGTTACATGCACCATATGGAATTACCAACTGGAGTTCAT +GCTGGCACAGACTTAGAAGGTAACTTTTATGGACCTTTTGTTGACAGGCAAACAGCACAAGCAGCTGGTA +CGGACACAACTATTACAGTTAATGTTTTAGCTTGGTTGTACGCTGCTGTTATAAATGGAGACAGGTGGTT +TCTCAATCGATTTACCACAACTCTTAATGACTTTAACCTTGTGGCTATGAAGTACAATTATGAACCTCTA +ACACAAGACCATGTTGACATACTAGGACCTCTTTCTGCTCAAACTGGAATTGCCGTTTTAGATATGTGTG +CTTCATTAAAAGAATTACTGCAAAATGGTATGAATGGACGTACCATATTGGGTAGTGCTTTATTAGAAGA +TGAATTTACACCTTTTGATGTTGTTAGACAATGCTCAGGTGTTACTTTCCAAAGTGCAGTGAAAAGAACA +ATCAAGGGTACACACCACTGGTTGTTACTCACAATTTTGACTTCACTTTTAGTTTTAGTCCAGAGTACTC +AATGGTCTTTGTTCTTTTTTTTGTATGAAAATGCCTTTTTACCTTTTGCTATGGGTATTATTGCTATGTC +TGCTTTTGCAATGATGTTTGTCAAACATAAGCATGCATTTCTCTGTTTGTTTTTGTTACCTTCTCTTGCC +ACTGTAGCTTATTTTAATATGGTCTATATGCCTGCTAGTTGGGTGATGCGTATTATGACATGGTTGGATA +TGGTTGATACTAGTTTGTCTGGTTTTAAGCTAAAAGACTGTGTTATGTATGCATCAGCTGTAGTGTTACT +AATCCTTATGACAGCAAGAACTGTGTATGATGATGGTGCTAGGAGAGTGTGGACACTTATGAATGTCTTG +ACACTCGTTTATAAAGTTTATTATGGTAATGCTTTAGATCAAGCCATTTCCATGTGGGCTCTTATAATCT +CTGTTACTTCTAACTACTCAGGTGTAGTTACAACTGTCATGTTTTTGGCCAGAGGTATTGTTTTTATGTG +TGTTGAGTATTGCCCTATTTTCTTCATAACTGGTAATACACTTCAGTGTATAATGCTAGTTTATTGTTTC +TTAGGCTATTTTTGTACTTGTTACTTTGGCCTCTTTTGTTTACTCAACCGCTACTTTAGACTGACTCTTG +GTGTTTATGATTACTTAGTTTCTACACAGGAGTTTAGATATATGAATTCACAGGGACTACTCCCACCCAA +GAATAGCATAGATGCCTTCAAACTCAACATTAAATTGTTGGGTGTTGGTGGCAAACCTTGTATCAAAGTA +GCCACTGTACAGTCTAAAATGTCAGATGTAAAGTGCACATCAGTAGTCTTACTCTCAGTTTTGCAACAAC +TCAGAGTAGAATCATCATCTAAATTGTGGGCTCAATGTGTCCAGTTACACAATGACATTCTCTTAGCTAA +AGATACTACTGAAGCCTTTGAAAAAATGGTTTCACTACTTTCTGTTTTGCTTTCCATGCAGGGTGCTGTA +GACATAAACAAGCTTTGTGAAGAAATGCTGGACAACAGGGCAACCTTACAAGCTATAGCCTCAGAGTTTA +GTTCCCTTCCATCATATGCAGCTTTTGCTACTGCTCAAGAAGCTTATGAGCAGGCTGTTGCTAATGGTGA +TTCTGAAGTTGTTCTTAAAAAGTTGAAGAAGTCTTTGAATGTGGCTAAATCTGAATTTGACCGTGATGCA +GCCATGCAACGTAAGTTGGAAAAGATGGCTGATCAAGCTATGACCCAAATGTATAAACAGGCTAGATCTG +AGGACAAGAGGGCAAAAGTTACTAGTGCTATGCAGACAATGCTTTTCACTATGCTTAGAAAGTTGGATAA +TGATGCACTCAACAACATTATCAACAATGCAAGAGATGGTTGTGTTCCCTTGAACATAATACCTCTTACA +ACAGCAGCCAAACTAATGGTTGTCATACCAGACTATAACACATATAAAAATACGTGTGATGGTACAACAT +TTACTTATGCATCAGCATTGTGGGAAATCCAACAGGTTGTAGATGCAGATAGTAAAATTGTTCAACTTAG +TGAAATTAGTATGGACAATTCACCTAATTTAGCATGGCCTCTTATTGTAACAGCTTTAAGGGCCAATTCT +GCTGTCAAATTACAGAATAATGAGCTTAGTCCTGTTGCACTACGACAGATGTCTTGTGCTGCCGGTACTA +CACAAACTGCTTGCACTGATGACAATGCGTTAGCTTACTACAACACAACAAAGGGAGGTAGGTTTGTACT +TGCACTGTTATCCGATTTACAGGATTTGAAATGGGCTAGATTCCCTAAGAGTGATGGAACTGGTACTATC +TATACAGAACTGGAACCACCTTGTAGGTTTGTTACAGACACACCTAAAGGTCCTAAAGTGAAGTATTTAT +ACTTTATTAAAGGATTAAACAACCTAAATAGAGGTATGGTACTTGGTAGTTTAGCTGCCACAGTACGTCT +ACAAGCTGGTAATGCAACAGAAGTGCCTGCCAATTCAACTGTATTATCTTTCTGTGCTTTTGCTGTAGAT +GCTGCTAAAGCTTACAAAGATTATCTAGCTAGTGGGGGACAACCAATCACTAATTGTGTTAAGATGTTGT +GTACACACACTGGTACTGGTCAGGCAATAACAGTTACACCGGAAGCCAATATGGATCAAGAATCCTTTGG +TGGTGCATCGTGTTGTCTGTACTGCCGTTGCCACATAGATCATCCAAATCCTAAAGGATTTTGTGACTTA +AAAGGTAAGTATGTACAAATACCTACAACTTGTGCTAATGACCCTGTGGGTTTTACACTTAAAAACACAG +TCTGTACCGTCTGCGGTATGTGGAAAGGTTATGGCTGTAGTTGTGATCAACTCCGCGAACCCATGCTTCA +GTCAGCTGATGCACAATCGTTTTTAAACGGGTTTGCGGTGTAAGTGCAGCCCGTCTTACACCGTGCGGCA +CAGGCACTAGTACTGATGTCGTATACAGGGCTTTTGACATCTACAATGATAAAGTAGCTGGTTTTGCTAA +ATTCCTAAAAACTAATTGTTGTCGCTTCCAAGAAAAGGACGAAGATGACAATTTAATTGATTCTTACTTT +GTAGTTAAGAGACACACTTTCTCTAACTACCAACATGAAGAAACAATTTATAATTTACTTAAGGATTGTC +CAGCTGTTGCTAAACATGACTTCTTTAAGTTTAGAATAGACGGTGACATGGTACCACATATATCACGTCA +ACGTCTTACTAAATACACAATGGCAGACCTCGTCTATGCTTTAAGGCATTTTGATGAAGGTAATTGTGAC +ACATTAAAAGAAATACTTGTCACATACAATTGTTGTGATGATGATTATTTCAATAAAAAGGACTGGTATG +ATTTTGTAGAAAACCCAGATATATTACGCGTATACGCCAACTTAGGTGAACGTGTACGCCAAGCTTTGTT +AAAAACAGTACAATTCTGTGATGCCATGCGAAATGCTGGTATTGTTGGTGTACTGACATTAGATAATCAA +GATCTCAATGGTAACTGGTATGATTTCGGTGATTTCATACAAACCACGCCAGGTAGTGGAGTTCCTGTTG +TAGATTCTTATTATTCATTGTTAATGCCTATATTAACCTTGACCAGGGCTTTAACTGCAGAGTCACATGT +TGACACTGACTTAACAAAGCCTTACATTAAGTGGGATTTGTTAAAATATGACTTCACGGAAGAGAGGTTA +AAACTCTTTGACCGTTATTTTAAATATTGGGATCAGACATACCACCCAAATTGTGTTAACTGTTTGGATG +ACAGATGCATTCTGCATTGTGCAAACTTTAATGTTTTATTCTCTACAGTGTTCCCACCTACAAGTTTTGG +ACCACTAGTGAGAAAAATATTTGTTGATGGTGTTCCATTTGTAGTTTCAACTGGATACCACTTCAGAGAG +CTAGGTGTTGTACATAATCAGGATGTAAACTTACATAGCTCTAGACTTAGTTTTAAGGAATTACTTGTGT +ATGCTGCTGACCCTGCTATGCACGCTGCTTCTGGTAATCTATTACTAGATAAACGCACTACGTGCTTTTC +AGTAGCTGCACTTACTAACAATGTTGCTTTTCAAACTGTCAAACCCGGTAATTTTAACAAAGACTTCTAT +GACTTTGCTGTGTCTAAGGGTTTCTTTAAGGAAGGAAGTTCTGTTGAATTAAAACACTTCTTCTTTGCTC +AGGATGGTAATGCTGCTATCAGCGATTATGACTACTATCGTTATAATCTACCAACAATGTGTGATATCAG +ACAACTACTATTTGTAGTTGAAGTTGTTGATAAGTACTTTGATTGTTACGATGGTGGCTGTATTAATGCT +AACCAAGTCATCGTCAACAACCTAGACAAATCAGCTGGTTTTCCATTTAATAAATGGGGTAAGGCTAGAC +TTTATTATGATTCAATGAGTTATGAGGATCAAGATGCACTTTTCGCATATACAAAACGTAATGTCATCCC +TACTATAACTCAAATGAATCTTAAGTATGCCATTAGTGCAAAGAATAGAGCTCGCACCGTAGCTGGTGTC +TCTATCTGTAGTACTATGACCAATAGACAGTTTCATCAAAAATTATTGAAATCAATAGCCGCCACTAGAG +GAGCTACTGTAGTAATTGGAACAAGCAAATTCTATGGTGGTTGGCACAACATGTTAAAAACTGTTTATAG +TGATGTAGAAAACCCTCACCTTATGGGTTGGGATTATCCTAAATGTGATAGAGCCATGCCTAACATGCTT +AGAATTATGGCCTCACTTGTTCTTGCTCGCAAACATACAACGTGTTGTAGCTTGTCACACCGTTTCTATA +GATTAGCTAATGAGTGTGCTCAAGTATTGAGTGAAATGGTCATGTGTGGCGGTTCACTATATGTTAAACC +AGGTGGAACCTCATCAGGAGATGCCACAACTGCTTATGCTAATAGTGTTTTTAACATTTGTCAAGCTGTC +ACGGCCAATGTTAATGCACTTTTATCTACTGATGGTAACAAAATTGCCGATAAGTATGTCCGCAATTTAC +AACACAGACTTTATGAGTGTCTCTATAGAAATAGAGATGTTGACACAGACTTTGTGAATGAGTTTTACGC +ATATTTGCGTAAACATTTCTCAATGATGATACTCTCTGACGATGCTGTTGTGTGTTTCAATAGCACTTAT +GCATCTCAAGGTCTAGTGGCTAGCATAAAGAACTTTAAGTCAGTTCTTTATTATCAAAACAATGTTTTTA +TGTCTGAAGCAAAATGTTGGACTGAGACTGACCTTACTAAAGGACCTCATGAATTTTGCTCTCAACATAC +AATGCTAGTTAAACAGGGTGATGATTATGTGTACCTTCCTTACCCAGATCCATCAAGAATCCTAGGGGCC +GGCTGTTTTGTAGATGATATCGTAAAAACAGATGGTACACTTATGATTGAACGGTTCGTGTCTTTAGCTA +TAGATGCTTACCCACTTACTAAACATCCTAATCAGGAGTATGCTGATGTCTTTCATTTGTACTTACAATA +CATAAGAAAGCTACATGATGAGTTAACAGGACACATGTTAGACATGTATTCTGTTATGCTTACTAATGAT +AACACTTCAAGGTATTGGGAACCTGAGTTTTATGAGGCTATGTACACACCGCATACAGTCTTACAGGCTG +TTGGGGCTTGTGTTCTTTGCAATTCACAGACTTCATTAAGATGTGGTGCTTGCATACGTAGACCATTCTT +ATGTTGTAAATGCTGTTACGACCATGTCATATCAACATCACATAAATTAGTCTTGTCTGTTAATCCGTAT +GTTTGCAATGCTCCAGGTTGTGATGTCACAGATGTGACTCAACTTTACTTAGGAGGTATGAGCTATTATT +GTAAATCACATAAACCACCCATTAGTTTTCCATTGTGTGCTAATGGACAAGTTTTTGGTTTATATAAAAA +TACATGTGTTGGTAGCGATAATGTTACTGACTTTAATGCAATTGCAACATGTGACTGGACAAATGCTGGT +GATTACATTTTAGCTAACACCTGTACTGAAAGACTCAAGCTTTTTGCAGCAGAAACGCTCAAAGCTACTG +AGGAGACATTTAAACTGTCTTATGGTATTGCTACTGTACGTGAAGTGCTGTCTGACAGAGAATTACATCT +TTCATGGGAAGTTGGTAAACCTAGACCACCACTTAACCGAAATTATGTCTTTACTGGTTATCGTGTAACT +AAAAACAGTAAAGTACAAATAGGAGAGTACACCTTTGAAAAAGGTGACTATGGTGATGCTGTTGTTTACC +GAGGTACAACAACTTACAAATTAAATGTTGGTGATTATTTTGTGCTGACATCACATACAGTAATGCCATT +AAGTGCACCTACACTAGTGCCACAAGAGCACTATGTTAGAATTACTGGCTTATACCCAACACTCAATATC +TCAGATGAGTTTTCTAGCAATGTTGCAAATTATCAAAAGGTTGGTATGCAAAAGTATTCTACACTCCAGG +GACCACCTGGTACTGGTAAGAGTCATTTTGCTATTGGCCTAGCTCTCTACTACCCTTCTGCTCGCATAGT +GTATACAGCTTGCTCTCATGCCGCTGTTGATGCACTATGTGAGAAGGCATTAAAATATTTGCCTATAGAT +AAATGTAGTAGAATTATACCTGCACGTGCTCGTGTAGAGTGTTTTGATAAATTCAAAGTGAATTCAACAT +TAGAACAGTATGTCTTTTGTACTGTAAATGCATTGCCTGAGACGACAGCAGATATAGTTGTCTTTGATGA +AATTTCAATGGCCACAAATTATGATTTGAGTGTTGTCAATGCCAGATTACGTGCTAAGCACTATGTGTAC +ATTGGCGACCCTGCTCAATTACCTGCACCACGCACATTGCTAACTAAGGGCACACTAGAACCAGAATATT +TCAATTCAGTGTGTAGACTTATGAAAACTATAGGTCCAGACATGTTCCTCGGAACTTGTCGGCGTTGTCC +TGCTGAAATTGTTGACACTGTGAGTGCTTTGGTTTATGATAATAAGCTTAAAGCACATAAAGACAAATCA +GCTCAATGCTTTAAAATGTTTTATAAGGGTGTTATCACGCATGATGTTTCATCTGCAATTAACAGGCCAC +AAATAGGCGTGGTAAGAGAATTCCTTACACGTAACCCTGCTTGGAGAAAAGCTGTCTTTATTTCACCTTA +TAATTCACAGAATGCTGTAGCCTCAAAGATTTTGGGACTACCAACTCAAACTGTTGATTCATCACAGGGC +TCAGAATATGACTATGTCATATTCACTCAAACCACTGAAACAGCTCACTCTTGTAATGTAAACAGATTTA +ATGTTGCTATTACCAGAGCAAAAGTAGGCATACTTTGCATAATGTCTGATAGAGACCTTTATGACAAGTT +GCAATTTACAAGTCTTGAAATTCCACGTAGGAATGTGGCAACTTTACAAGCTGAAAATGTAACAGGACTC +TTTAAAGATTGTAGTAAGGTAATCACTGGGTTACATCCTACACAGGCACCTACACACCTCAGTGTTGACA +CTAAATTCAAAACTGAAGGTTTATGTGTTGACATACCTGGCATACCTAAGGACATGACCTATAGAAGACT +CATCTCTATGATGGGTTTTAAAATGAATTATCAAGTTAATGGTTACCCTAACATGTTTATCACCCGCGAA +GAAGCTATAAGACATGTACGTGCATGGATTGGCTTCGATGTCGAGGGGTGTCATGCTACTAGAGAAGCTG +TTGGTACCAATTTACCTTTACAGCTAGGTTTTTCTACAGGTGTTAACCTAGTTGCTGTACCTACAGGTTA +TGTTGATACACCTAATAATACAGATTTTTCCAGAGTTAGTGCTAAACCACCGCCTGGAGATCAATTTAAA +CACCTCATACCACTTATGTACAAAGGACTTCCTTGGAATGTAGTGCGTATAAAGATTGTACAAATGTTAA +GTGACACACTTAAAAATCTCTCTGACAGAGTCGTATTTGTCTTATGGGCACATGGCTTTGAGTTGACATC +TATGAAGTATTTTGTGAAAATAGGACCTGAGCGCACCTGTTGTCTATGTGATAGACGTGCCACATGCTTT +TCCACTGCTTCAGACACTTATGCCTGTTGGCATCATTCTATTGGATTTGATTACGTCTATAATCCGTTTA +TGATTGATGTTCAACAATGGGGTTTTACAGGTAACCTACAAAGCAACCATGATCTGTATTGTCAAGTCCA +TGGTAATGCACATGTAGCTAGTTGTGATGCAATCATGACTAGGTGTCTAGCTGTCCACGAGTGCTTTGTT +AAGCGTGTTGACTGGACTATTGAATATCCTATAATTGGTGATGAACTGAAGATTAATGCGGCTTGTAGAA +AGGTTCAACACATGGTTGTTAAAGCTGCATTATTAGCAGACAAATTCCCAGTTCTTCACGACATTGGTAA +CCCTAAAGCTATTAAGTGTGTACCTCAAGCTGATGTAGAATGGAAGTTCTATGATGCACAGCCTTGTAGT +GACAAAGCTTATAAAATAGAAGAATTATTCTATTCTTATGCCACACATTCTGACAAATTCACAGATGGTG +TATGCCTATTTTGGAATTGCAATGTCGATAGATATCCTGCTAATTCCATTGTTTGTAGATTTGACACTAG +AGTGCTATCTAACCTTAACTTGCCTGGTTGTGATGGTGGCAGTTTGTATGTAAATAAACATGCATTCCAC +ACACCAGCTTTTGATAAAAGTGCTTTTGTTAATTTAAAACAATTACCATTTTTCTATTACTCTGACAGTC +CATGTGAGTCTCATGGAAAACAAGTAGTGTCAGATATAGATTATGTACCACTAAAGTCTGCTACGTGTAT +AACACGTTGCAATTTAGGTGGTGCTGTCTGTAGACATCATGCTAATGAGTACAGATTGTATCTCGATGCT +TATAACATGATGATCTCAGCTGGCTTTAGCTTGTGGGTTTACAAACAATTTGATACTTATAACCTCTGGA +ACACTTTTACAAGACTTCAGAGTTTAGAAAATGTGGCTTTTAATGTTGTAAATAAGGGACACTTTGATGG +ACAACAGGGTGAAGTACCAGTTTCTATCATTAATAACACTGTTTACACAAAAGTTGATGGTGTTGATGTA +GAATTGTTTGAAAATAAAACAACATTACCTGTTAATGTAGCATTTGAGCTTTGGGCTAAGCGCAACATTA +AACCAGTACCAGAGGTGAAAATACTCAATAATTTGGGTGTGGACATTGCTGCTAATACTGTGATCTGGGA +CTACAAAAGAGATGCTCCAGCACATATATCTACTATTGGTGTTTGTTCTATGACTGACATAGCCAAGAAA +CCAACTGAAACGATTTGTGCACCACTCACTGTCTTTTTTGATGGTAGAGTTGATGGTCAAGTAGACTTAT +TTAGAAATGCCCGTAATGGTGTTCTTATTACAGAAGGTAGTGTTAAAGGTTTACAACCATCTGTAGGTCC +CAAACAAGCTAGTCTTAATGGAGTCACATTAATTGGAGAAGCCGTAAAAACACAGTTCAATTATTATAAG +AAAGTTGATGGTGTTGTCCAACAATTACCTGAAACTTACTTTACTCAGAGTAGAAATTTACAAGAATTTA +AACCCAGGAGTCAAATGGAAATTGATTTCTTAGAATTAGCTATGGATGAATTCATTGAACGGTATAAATT +AGAAGGCTATGCCTTCGAACATATCGTTTATGGAGATTTTAGTCATAGTCAGTTAGGTGGTTTACATCTA +CTGATTGGACTAGCTAAACGTTTTAAGGAATCACCTTTTGAATTAGAAGATTTTATTCCTATGGACAGTA +CAGTTAAAAACTATTTCATAACAGATGCGCAAACAGGTTCATCTAAGTGTGTGTGTTCTGTTATTGATTT +ATTACTTGATGATTTTGTTGAAATAATAAAATCCCAAGATTTATCTGTAGTTTCTAAGGTTGTCAAAGTG +ACTATTGACTATACAGAAATTTCATTTATGCTTTGGTGTAAAGATGGCCATGTAGAAACATTTTACCCAA +AATTACAATCTAGTCAAGCGTGGCAACCGGGTGTTGCTATGCCTAATCTTTACAAAATGCAAAGAATGCT +ATTAGAAAAGTGTGACCTTCAAAATTATGGTGATAGTGCAACATTACCTAAAGGCATAATGATGAATGTC +GCAAAATATACTCAACTGTGTCAATATTTAAACACATTAACATTAGCTGTACCCTATAATATGAGAGTTA +TACATTTTGGTGCTGGTTCTGATAAAGGAGTTGCACCAGGTACAGCTGTTTTAAGACAGTGGTTGCCTAC +GGGTACGCTGCTTGTCGATTCAGATCTTAATGACTTTGTCTCTGATGCAGATTCAACTTTGATTGGTGAT +TGTGCAACTGTACATACAGCTAATAAATGGGATCTCATTATTAGTGATATGTACGACCCTAAGACTAAAA +ATGTTACAAAAGAAAATGACTCTAAAGAGGGTTTTTTCACTTACATTTGTGGGTTTATACAACAAAAGCT +AGCTCTTGGAGGTTCCGTGGCTATAAAGATAACAGAACATTCTTGGAATGCTGATCTTTATAAGCTCATG +GGACACTTCGCATGGTGGACAGCCTTTGTTACTAATGTGAATGCGTCATCATCTGAAGCATTTTTAATTG +GATGTAATTATCTTGGCAAACCACGCGAACAAATAGATGGTTATGTCATGCATGCAAATTACATATTTTG +GAGGAATACAAATCCAATTCAGTTGTCTTCCTATTCTTTATTTGACATGAGTAAATTTCCCCTTAAATTA +AGGGGTACTGCTGTTATGTCTTTAAAAGAAGGTCAAATCAATGATATGATTTTATCTCTTCTTAGTAAAG +GTAGACTTATAATTAGAGAAAACAACAGAGTTGTTATTTCTAGTGATGTTCTTGTTAACAACTAAACGAA +CAATGTTTGTTTTTCTTGTTTTATTGCCACTAGTCTCTAGTCAGTGTGTTAATCTTACAACCAGAACTCA +ATTACCCCCTGCATACACTAATTCTTTCACACGTGGTGTTTATTACCCTGACAAAGTTTTCAGATCCTCA +GTTTTACATTCAACTCAGGACTTGTTCTTACCTTTCTTTTCCAATGTTACTTGGTTCCATGCTATACATG +TCTCTGGGACCAATGGTACTAAGAGGTTTGATAACCCTGTCCTACCATTTAATGATGGTGTTTATTTTGC +TTCCACTGAGAAGTCTAACATAATAAGAGGCTGGATTTTTGGTACTACTTTAGATTCGAAGACCCAGTCC +CTACTTATTGTTAATAACGCTACTAATGTTGTTATTAAAGTCTGTGAATTTCAATTTTGTAATGATCCAT +TTTTGGGTGTTTATTACCACAAAAACAACAAAAGTTGGATGGAAAGTGAGTTCAGAGTTTATTCTAGTGC +GAATAATTGCACTTTTGAATATGTCTCTCAGCCTTTTCTTATGGACCTTGAAGGAAAACAGGGTAATTTC +AAAAATCTTAGGGAATTTGTGTTTAAGAATATTGATGGTTATTTTAAAATATATTCTAAGCACACGCCTA +TTAATTTAGTGCGTGATCTCCCTCAGGGTTTTTCGGCTTTAGAACCATTGGTAGATTTGCCAATAGGTAT +TAACATCACTAGGTTTCAAACTTTACTTGCTTTACATAGAAGTTATTTGACTCCTGGTGATTCTTCTTCA +GGTTGGACAGCTGGTGCTGCAGCTTATTATGTGGGTTATCTTCAACCTAGGACTTTTCTATTAAAATATA +ATGAAAATGGAACCATTACAGATGCTGTAGACTGTGCACTTGACCCTCTCTCAGAAACAAAGTGTACGTT +GAAATCCTTCACTGTAGAAAAAGGAATCTATCAAACTTCTAACTTTAGAGTCCAACCAACAGAATCTATT +GTTAGATTTCCTAATATTACAAACTTGTGCCCTTTTGGTGAAGTTTTTAACGCCACCAGATTTGCATCTG +TTTATGCTTGGAACAGGAAGAGAATCAGCAACTGTGTTGCTGATTATTCTGTCCTATATAATTCCGCATC +ATTTTCCACTTTTAAGTGTTATGGAGTGTCTCCTACTAAATTAAATGATCTCTGCTTTACTAATGTCTAT +GCAGATTCATTTGTAATTAGAGGTGATGAAGTCAGACAAATCGCTCCAGGGCAAACTGGAAAGATTGCTG +ATTATAATTATAAATTACCAGATGATTTTACAGGCTGCGTTATAGCTTGGAATTCTAACAATCTTGATTC +TAAGGTTGGTGGTAATTATAATTACCTGTATAGATTGTTTAGGAAGTCTAATCTCAAACCTTTTGAGAGA +GATATTTCAACTGAAATCTATCAGGCCGGTAGCACACCTTGTAATGGTGTTGAAGGTTTTAATTGTTACT +TTCCTTTACAATCATATGGTTTCCAACCCACTAATGGTGTTGGTTACCAACCATACAGAGTAGTAGTACT +TTCTTTTGAACTTCTACATGCACCAGCAACTGTTTGTGGACCTAAAAAGTCTACTAATTTGGTTAAAAAC +AAATGTGTCAATTTCAACTTCAATGGTTTAACAGGCACAGGTGTTCTTACTGAGTCTAACAAAAAGTTTC +TGCCTTTCCAACAATTTGGCAGAGACATTGCTGACACTACTGATGCTGTCCGTGATCCACAGACACTTGA +GATTCTTGACATTACACCATGTTCTTTTGGTGGTGTCAGTGTTATAACACCAGGAACAAATACTTCTAAC +CAGGTTGCTGTTCTTTATCAGGATGTTAACTGCACAGAAGTCCCTGTTGCTATTCATGCAGATCAACTTA +CTCCTACTTGGCGTGTTTATTCTACAGGTTCTAATGTTTTTCAAACACGTGCAGGCTGTTTAATAGGGGC +TGAACATGTCAACAACTCATATGAGTGTGACATACCCATTGGTGCAGGTATATGCGCTAGTTATCAGACT +CAGACTAATTCTCCTCGGCGGGCACGTAGTGTAGCTAGTCAATCCATCATTGCCTACACTATGTCACTTG +GTGCAGAAAATTCAGTTGCTTACTCTAATAACTCTATTGCCATACCCACAAATTTTACTATTAGTGTTAC +CACAGAAATTCTACCAGTGTCTATGACCAAGACATCAGTAGATTGTACAATGTACATTTGTGGTGATTCA +ACTGAATGCAGCAATCTTTTGTTGCAATATGGCAGTTTTTGTACACAATTAAACCGTGCTTTAACTGGAA +TAGCTGTTGAACAAGACAAAAACACCCAAGAAGTTTTTGCACAAGTCAAACAAATTTACAAAACACCACC +AATTAAAGATTTTGGTGGTTTTAATTTTTCACAAATATTACCAGATCCATCAAAACCAAGCAAGAGGTCA +TTTATTGAAGATCTACTTTTCAACAAAGTGACACTTGCAGATGCTGGCTTCATCAAACAATATGGTGATT +GCCTTGGTGATATTGCTGCTAGAGACCTCATTTGTGCACAAAAGTTTAACGGCCTTACTGTTTTGCCACC +TTTGCTCACAGATGAAATGATTGCTCAATACACTTCTGCACTGTTAGCGGGTACAATCACTTCTGGTTGG +ACCTTTGGTGCAGGTGCTGCATTACAAATACCATTTGCTATGCAAATGGCTTATAGGTTTAATGGTATTG +GAGTTACACAGAATGTTCTCTATGAGAACCAAAAATTGATTGCCAACCAATTTAATAGTGCTATTGGCAA +AATTCAAGACTCACTTTCTTCCACAGCAAGTGCACTTGGAAAACTTCAAGATGTGGTCAACCAAAATGCA +CAAGCTTTAAACACGCTTGTTAAACAACTTAGCTCCAATTTTGGTGCAATTTCAAGTGTTTTAAATGATA +TCCTTTCACGTCTTGACAAAGTTGAGGCTGAAGTGCAAATTGATAGGTTGATCACAGGCAGACTTCAAAG +TTTGCAGACATATGTGACTCAACAATTAATTAGAGCTGCAGAAATCAGAGCTTCTGCTAATCTTGCTGCT +ACTAAAATGTCAGAGTGTGTACTTGGACAATCAAAAAGAGTTGATTTTTGTGGAAAGGGCTATCATCTTA +TGTCCTTCCCTCAGTCAGCACCTCATGGTGTAGTCTTCTTGCATGTGACTTATGTCCCTGCACAAGAAAA +GAACTTCACAACTGCTCCTGCCATTTGTCATGATGGAAAAGCACACTTTCCTCGTGAAGGTGTCTTTGTT +TCAAATGGCACACACTGGTTTGTAACACAAAGGAATTTTTATGAACCACAAATCATTACTACAGACAACA +CATTTGTGTCTGGTAACTGTGATGTTGTAATAGGAATTGTCAACAACACAGTTTATGATCCTTTGCAACC +TGAATTAGACTCATTCAAGGAGGAGTTAGATAAATATTTTAAGAATCATACATCACCAGATGTTGATTTA +GGTGACATCTCTGGCATTAATGCTTCAGTTGTAAACATTCAAAAAGAAATTGACCGCCTCAATGAGGTTG +CCAAGAATTTAAATGAATCTCTCATCGATCTCCAAGAACTTGGAAAGTATGAGCAGTATATAAAATGGCC +ATGGTACATTTGGCTAGGTTTTATAGCTGGCTTGATTGCCATAGTAATGGTGACAATTATGCTTTGCTGT +ATGACCAGTTGCTGTAGTTGTCTCAAGGGCTGTTGTTCTTGTGGATCCTGCTGCAAATTTGATGAAGACG +ACTCTGAGCCAGTGCTCAAAGGAGTCAAATTACATTACACATAAACGAACTTATGGATTTGTTTATGAGA +ATCTTCACAATTGGAACTGTAACTTTGAAGCAAGGTGAAATCAAGGATGCTACTCCTTCAGATTTTGTTC +GCGCTACTGCAACGATACCGATACAAGCCTCACTCCCTTTCGGATGGCTTATTGTTGGCGTTGCACTTCT +TGCTGTTTTTCAGAGCGCTTCCAAAATCATAACCCTCAAAAAGAGATGGCAACTAGCACTCTCCAAGGGT +GTTCACTTTGTTTGCAACTTGCTGTTGTTGTTTGTAACAGTTTACTCACACCTTTTGCTCGTTGCTGCTG +GCCTTGAAGCCCCTTTTCTCTATCTTTATGCTTTAGTCTACTTCTTGCAGAGTATAAACTTTGTAAGAAT +AATAATGAGGCTTTGGCTTTGCTGGAAATGCCGTTCCAAAAACCCATTACTTTATGATGCCAACTATTTT +CTTTGCTGGCATACTAATTGTTACGACTATTGTATACCTTACAATAGTGTAACTTCTTCAATTGTCATTA +CTTCAGGTGATGGCACAACAAGTCCTATTTCTGAACATGACTACCAGATTGGTGGTTATACTGAAAAATG +GGAATCTGGAGTAAAAGACTGTGTTGTATTACACAGTTACTTCACTTCAGACTATTACCAGCTGTACTCA +ACTCAATTGAGTACAGACACTGGTGTTGAACATGTTACCTTCTTCATCTACAATAAAATTGTTGATGAGC +CTGAAGAACATGTCCAAATTCACACAATCGACGGTTCATCCGGAGTTGTTAATCCAGTAATGGAACCAAT +TTATGATGAACCGACGACGACTACTAGCGTGCCTTTGTAAGCACAAGCTGATGAGTACGAACTTATGTAC +TCATTCGTTTCGGAAGAGACAGGTACGTTAATAGTTAATAGCGTACTTCTTTTTCTTGCTTTCGTGGTAT +TCTTGCTAGTTACACTAGCCATCCTTACTGCGCTTCGATTGTGTGCGTACTGCTGCAATATTGTTAACGT +GAGTCTTGTAAAACCTTCTTTTTACGTTTACTCTCGTGTTAAAAATCTGAATTCTTCTAGAGTTCCTGAT +CTTCTGGTCTAAACGAACTAAATATTATATTAGTTTTTCTGTTTGGAACTTTAATTTTAGCCATGGCAGA +TTCCAACGGTACTATTACCGTTGAAGAGCTTAAAAAGCTCCTTGAACAATGGAACCTAGTAATAGGTTTC +CTATTCCTTACATGGATTTGTCTTCTACAATTTGCCTATGCCAACAGGAATAGGTTTTTGTATATAATTA +AGTTAATTTTCCTCTGGCTGTTATGGCCAGTAACTTTAGCTTGTTTTGTGCTTGCTGCTGTTTACAGAAT +AAATTGGATCACCGGTGGAATTGCTATCGCAATGGCTTGTCTTGTAGGCTTGATGTGGCTCAGCTACTTC +ATTGCTTCTTTCAGACTGTTTGCGCGTACGCGTTCCATGTGGTCATTCAATCCAGAAACTAACATTCTTC +TCAACGTGCCACTCCATGGCACTATTCTGACCAGACCGCTTCTAGAAAGTGAACTCGTAATCGGAGCTGT +GATCCTTCGTGGACATCTTCGTATTGCTGGACACCATCTAGGACGCTGTGACATCAAGGACCTGCCTAAA +GAAATCACTGTTGCTACATCACGAACGCTTTCTTATTACAAATTGGGAGCTTCGCAGCGTGTAGCAGGTG +ACTCAGGTTTTGCTGCATACAGTCGCTACAGGATTGGCAACTATAAATTAAACACAGACCATTCCAGTAG +CAGTGACAATATTGCTTTGCTTGTACAGTAAGTGACAACAGATGTTTCATCTCGTTGACTTTCAGGTTAC +TATAGCAGAGATATTACTAATTATTATGAGGACTTTTAAAGTTTCCATTTGGAATCTTGATTACATCATA +AACCTCATAATTAAAAATTTATCTAAGTCACTAACTGAGAATAAATATTCTCAATTAGATGAAGAGCAAC +CAATGGAGATTGATTAAACGAACATGAAAATTATTCTTTTCTTGGCACTGATAACACTCGCTACTTGTGA +GCTTTATCACTACCAAGAGTGTGTTAGAGGTACAACAGTACTTTTAAAAGAACCTTGCTCTTCTGGAACA +TACGAGGGCAATTCACCATTTCATCCTCTAGCTGATAACAAATTTGCACTGACTTGCTTTAGCACTCAAT +TTGCTTTTGCTTGTCCTGACGGCGTAAAACACGTCTATCAGTTACGTGCCAGATCAGTTTCACCTAAACT +GTTCATCAGACAAGAGGAAGTTCAAGAACTTTACTCTCCAATTTTTCTTATTGTTGCGGCAATAGTGTTT +ATAACACTTTGCTTCACACTCAAAAGAAAGACAGAATGATTGAACTTTCATTAATTGACTTCTATTTGTG +CTTTTTAGCCTTTCTGCTATTCCTTGTTTTAATTATGCTTATTATCTTTTGGTTCTCACTTGAACTGCAA +GATCATAATGAAACTTGTCACGCCTAAACGAACATGAAATTTCTTGTTTTCTTAGGAATCATCACAACTG +TAGCTGCATTTCACCAAGAATGTAGTTTACAGTCATGTACTCAACATCAACCATATGTAGTTGATGACCC +GTGTCCTATTCACTTCTATTCTAAATGGTATATTAGAGTAGGAGCTAGAAAATCAGCACCTTTAATTGAA +TTGTGCGTGGATGAGGCTGGTTCTAAATCACCCATTCAGTACATCGATATCGGTAATTATACAGTTTCCT +GTTTACCTTTTACAATTAATTGCCAGGAACCTAAATTGGGTAGTCTTGTAGTGCGTTGTTCGTTCTATGA +AGACTTTTTAGAGTATCATGACGTTCGTGTTGTTTTAGATTTCATCTAAACGAACAAACTAAAATGTCTG +ATAATGGACCCCAAAATCAGCGAAATGCACCCCGCATTACGTTTGGTGGACCCTCAGATTCAACTGGCAG +TAACCAGAATGGAGAACGCAGTGGGGCGCGATCAAAACAACGTCGGCCCCAAGGTTTACCCAATAATACT +GCGTCTTGGTTCACCGCTCTCACTCAACATGGCAAGGAAGACCTTAAATTCCCTCGAGGACAAGGCGTTC +CAATTAACACCAATAGCAGTCCAGATGACCAAATTGGCTACTACCGAAGAGCTACCAGACGAATTCGTGG +TGGTGACGGTAAAATGAAAGATCTCAGTCCAAGATGGTATTTCTACTACCTAGGAACTGGGCCAGAAGCT +GGACTTCCCTATGGTGCTAACAAAGACGGCATCATATGGGTTGCAACTGAGGGAGCCTTGAATACACCAA +AAGATCACATTGGCACCCGCAATCCTGCTAACAATGCTGCAATCGTGCTACAACTTCCTCAAGGAACAAC +ATTGCCAAAAGGCTTCTACGCAGAAGGGAGCAGAGGCGGCAGTCAAGCCTCTTCTCGTTCCTCATCACGT +AGTCGCAACAGTTCAAGAAATTCAACTCCAGGCAGCAGTAGGGGAACTTCTCCTGCTAGAATGGCTGGCA +ATGGCGGTGATGCTGCTCTTGCTTTGCTGCTGCTTGACAGATTGAACCAGCTTGAGAGCAAAATGTCTGG +TAAAGGCCAACAACAACAAGGCCAAACTGTCACTAAGAAATCTGCTGCTGAGGCTTCTAAGAAGCCTCGG +CAAAAACGTACTGCCACTAAAGCATACAATGTAACACAAGCTTTCGGCAGACGTGGTCCAGAACAAACCC +AAGGAAATTTTGGGGACCAGGAACTAATCAGACAAGGAACTGATTACAAACATTGGCCGCAAATTGCACA +ATTTGCCCCCAGCGCTTCAGCGTTCTTCGGAATGTCGCGCATTGGCATGGAAGTCACACCTTCGGGAACG +TGGTTGACCTACACAGGTGCCATCAAATTGGATGACAAAGATCCAAATTTCAAAGATCAAGTCATTTTGC +TGAATAAGCATATTGACGCATACAAAACATTCCCACCAACAGAGCCTAAAAAGGACAAAAAGAAGAAGGC +TGATGAAACTCAAGCCTTACCGCAGAGACAGAAGAAACAGCAAACTGTGACTCTTCTTCCTGCTGCAGAT +TTGGATGATTTCTCCAAACAATTGCAACAATCCATGAGCAGTGCTGACTCAACTCAGGCCTAAACTCATG +CAGACCACACAAGGCAGATGGGCTATATAAACGTTTTCGCTTTTCCGTTTACGATATATAGTCTACTCTT +GTGCAGAATGAATTCTCGTAACTACATAGCACAAGTAGATGTAGTTAACTTTAATCTCACATAGCAATCT +TTAATCAGTGTGTAACATTAGGGAGGACTTGAAAGAGCCACCACATTTTCACCGAGGCCACGCGGAGTAC +GATCGAGTGTACAGTGAACAATGCTAGGGAGAGCTGCCTATATGGAAGAGCCCTAATGTGTAAAATTAAT +TTTAGTAGTGCTATCCCCATGTGATTTTAATAGCTTCTTAGGAGAATGACAAAAAAAAAAAAAAAAAAAA +AAAAAAAAAAAAA diff --git a/backend/apis/spike_annotations.tsv b/backend/apis/spike_annotations.tsv new file mode 100644 index 0000000..d10256b --- /dev/null +++ b/backend/apis/spike_annotations.tsv @@ -0,0 +1,10 @@ +Protein Annotation Short_annotation Start Stop +Spike (surface glycoprotein) signal peptide at N-terminus 1 13 +Spike (surface glycoprotein) N-terminal domain NTD 14 305 +Spike (surface glycoprotein) Receptor binding domain RBD 319 541 +Spike (surface glycoprotein) Receptor binding motif RBM 438 506 +Spike (surface glycoprotein) fusion peptide FP 788 806 +Spike (surface glycoprotein) heptapeptide repeat sequence 1 HR1 912 984 +Spike (surface glycoprotein) heptapeptide repeat sequence 2 HR2 1163 1213 +Spike (surface glycoprotein) TM domain TM 1213 1237 +Spike (surface glycoprotein) cytoplasm domain CD 1237 1273 diff --git a/backend/apis/ufl.py b/backend/apis/ufl.py new file mode 100644 index 0000000..d94cc79 --- /dev/null +++ b/backend/apis/ufl.py @@ -0,0 +1,58 @@ +import json +import urllib + +import requests +import http.client + +from flask_restplus import Namespace, Resource + + +api = Namespace('ufl', description='ufl') + +http.client._MAXLINE = 655360 + +######################################################################################################## + + +@api.route('') +class FieldList(Resource): + @api.doc('get_field_list') + def get(self): + response = requests.get("http://geco.deib.polimi.it/virusurf_epitope/api/epitope/allEpitopes") + myobj = [('c101', 'B.1'), ('c103', 'B.1.243')] + + url = 'http://geco.deib.polimi.it/virusurf_epitope/api/epitope/statisticsMutationsLineages' + + myobj2 = [('c101', 'B.1'), ('c103', 'B.1.243'), ('c114', 'B.1.240'), ('c12', 'B.1.351'), ('c122', 'B.1'), ('c125', 'B.1.381'), ('c126', 'B.1.381'), ('c128', 'B.1.381'), ('c129', 'B.1.381'), ('c131', 'B.1.237'), ('c133', 'A'), ('c133', 'B'), ('c133', 'B.23'), ('c133', 'B.29'), ('c133', 'B.3'), ('c133', 'B.39'), ('c133', 'B.40'), ('c133', 'B.52'), ('c133', 'B.6'), ('c14', 'B.1.351'), ('c149', 'B.1.1.254'), ('c151', 'B.1.1.254'), ('c153', 'B.1'), ('c153', 'B.1.1.254'), ('c153', 'B.1.1.269'), ('c163', 'B.1.1.119'), ('c176', 'B.1.1.117'), ('c182', 'B.1.1.119'), ('c182', 'B.1.1.220'), ('c199', 'B.1.1.84'), ('c203', 'B.1.1.34'), ('c204', 'B.1.1.34'), ('c208', 'B.1.1.62'), ('c210', 'B.1.1.314'), ('c210', 'B.1.1.33'), ('c211', 'B.1.1.216'), ('c211', 'B.1.1.4'), ('c211', 'B.1.1.75'), ('c217', 'B.1.1.109'), ('c221', 'B.1.1.7'), ('c224', 'H.1'), ('c225', 'B.1.1.67'), ('c227', 'B.1.1.53'), ('c228', 'B.1.1.53'), ('c240', 'C.1'), ('c242', 'C.1'), ('c255', 'C.9'), ('c257', 'C.9'), ('c259', 'B.1.1.1'), ('c259', 'C.2'), ('c260', 'B.1.1.1'), ('c263', 'B.1.1.1'), ('c269', 'B.1.1.1'), ('c28', 'B.1.351'), ('c282', 'B.1.1.57'), ('c285', 'B.1.1.57'), ('c289', 'B.1.1.311'), ('c29', 'B.1.351'), ('c290', 'B.1.1.309'), ('c291', 'B.1.1.119'), ('c291', 'B.1.1.52'), ('c293', 'B.1.1.281'), ('c293', 'B.1.1.306'), ('c299', 'B.1.1.273'), ('c301', 'B.1.1.273'), ('c301', 'B.1.146'), ('c310', 'H.1'), ('c320', 'B.1.1.67'), ('c320', 'H.1'), ('c326', 'B.1.1.56'), ('c329', 'B.1.1.119'), ('c329', 'B.1.1.208'), ('c329', 'B.1.1.37'), ('c329', 'B.1.1.62'), ('c334', 'B.1.1.206'), ('c342', 'B.1.1.206'), ('c347', 'B.1.1.206'), ('c350', 'B.1.1.206'), ('c371', 'B.1.1.206'), ('c375', 'B.1.1.206'), ('c375', 'B.1.1.54'), ('c379', 'B.1.1.206'), ('c38', 'B.1.351'), ('c384', 'B.1.1.206'), ('c389', 'B.1.1.206'), ('c39', 'B.1.351'), ('c4', 'B.1.351'), ('c45', 'B.1.351'), ('c46', 'B.1.351'), ('c47', 'B.1.351'), ('c49', 'B.1.351'), ('c65', 'B.1.140'), ('c72', 'B.1.106'), ('c73', 'B.1.106'), ('c78', 'B.1.177'), ('c78', 'B.1.177.1'), ('c78', 'B.1.177.12'), ('c78', 'B.1.177.14'), ('c78', 'B.1.177.16'), ('c78', 'B.1.177.18'), ('c78', 'B.1.177.24'), ('c93', 'B.1'), ('c93', 'B.1.157'), ('c93', 'B.1.237'), ('c97', 'B.1'), ('c99', 'B.1.417')] + + + + conn = http.client.HTTPConnection('geco.deib.polimi.it') + + headers = {'Content-type': 'application/json'} + + foo = myobj2 + json_data = json.dumps(foo) + + conn.request('GET', '/virusurf_epitope/api/epitope/statisticsMutationsLineagesGET') + + response2 = conn.getresponse() + res = response2.read().decode() + # print(res) + # print("len", len(res)) + + lineage_stats = json.loads(res) + + # def test(): + # with requests.post(url, data=myobj2, stream=True) as r: + # for chunk in r.iter_lines(decode_unicode=True): + # decoded_line = chunk.decode('utf-8') + # yield decoded_line + # + # aaa = test() + # x = json.loads(''.join(aaa)) + + res = {'res1': response.json(), 'res2': lineage_stats} + + return res + diff --git a/backend/app.py b/backend/app.py index eed22f6..96bfdd6 100644 --- a/backend/app.py +++ b/backend/app.py @@ -2,14 +2,11 @@ from logging.config import dictConfig import flask -from flask import Flask, render_template, redirect, Blueprint, url_for +from flask import Flask, redirect, Blueprint, url_for, render_template from flask_cors import CORS from flask_executor import Executor from apis import api_blueprint -from model.models import db -from utils import load_viruses -from apis import epitope base_url = '/ufl/' api_url = base_url + 'api' @@ -24,45 +21,45 @@ def get_env_variable(name): raise Exception(message) -def get_db_uri(): - database_name = "vcm_du_1" - - try: - # /home/metadata/virusurf_active_databases.txt - with open("/home/metadata/virusurf_active_databases.txt") as f: - lines = f.readlines() - database_name = [x for x in lines if 'gisaid' not in x][0] - except IOError: - pass - - # postgres_url = get_env_variable("POSTGRES_URL") - # postgres_user = get_env_variable("POSTGRES_USER") - # postgres_pw = get_env_variable("POSTGRES_PW") - # postgres_db = get_env_variable("POSTGRES_DB") - postgres_url = "localhost" - postgres_user = "geco" - postgres_pw = "geco78" - postgres_db = database_name.strip() - - application_name = [] - - if 'ENV' in my_app.config: - application_name.append(my_app.config['ENV']) - - application_name.append(os.uname()[1]) - - application_name.append(base_url) - - application_name = ", ".join(application_name) - - result = 'postgresql+psycopg2://{user}:{pw}@{url}/{db}?application_name="{application_name}"'.format( - user=postgres_user, - pw=postgres_pw, - url=postgres_url, - db=postgres_db, - application_name=application_name, ) - print(result) - return result +# def get_db_uri(): +# database_name = "vcm_du_1" +# +# try: +# # /home/metadata/virusurf_active_databases.txt +# with open("/home/metadata/virusurf_active_databases.txt") as f: +# lines = f.readlines() +# database_name = [x for x in lines if 'gisaid' not in x][0] +# except IOError: +# pass +# +# # postgres_url = get_env_variable("POSTGRES_URL") +# # postgres_user = get_env_variable("POSTGRES_USER") +# # postgres_pw = get_env_variable("POSTGRES_PW") +# # postgres_db = get_env_variable("POSTGRES_DB") +# postgres_url = "localhost" +# postgres_user = "geco" +# postgres_pw = "geco78" +# postgres_db = database_name.strip() +# +# application_name = [] +# +# if 'ENV' in my_app.config: +# application_name.append(my_app.config['ENV']) +# +# application_name.append(os.uname()[1]) +# +# application_name.append(base_url) +# +# application_name = ", ".join(application_name) +# +# result = 'postgresql+psycopg2://{user}:{pw}@{url}/{db}?application_name="{application_name}"'.format( +# user=postgres_user, +# pw=postgres_pw, +# url=postgres_url, +# db=postgres_db, +# application_name=application_name, ) +# print(result) +# return result dictConfig({ @@ -87,15 +84,15 @@ def get_db_uri(): my_app.debug = False -my_app.config['SQLALCHEMY_DATABASE_URI'] = get_db_uri() -my_app.config['SQLALCHEMY_TRACK_MODIFICATIONS'] = False -my_app.config['SQLALCHEMY_POOL_SIZE'] = 1 -my_app.config['SQLALCHEMY_MAX_OVERFLOW'] = 30 +# my_app.config['SQLALCHEMY_DATABASE_URI'] = get_db_uri() +# my_app.config['SQLALCHEMY_TRACK_MODIFICATIONS'] = False +# my_app.config['SQLALCHEMY_POOL_SIZE'] = 1 +# my_app.config['SQLALCHEMY_MAX_OVERFLOW'] = 30 my_app.config['EXECUTOR_PROPAGATE_EXCEPTIONS'] = True my_app.config['EXECUTOR_MAX_WORKERS'] = 20 -db.init_app(my_app) +# db.init_app(my_app) executor_inner = Executor(my_app) @@ -116,12 +113,14 @@ def index(): flask.current_app.logger.info("serve index") return render_template('index.html') + # base url defined in apis init @simple_page.route('/epitope/') def index_epitope(): flask.current_app.logger.info("serve index") return render_template('index.html') + # Make a "catch all route" so all requests match our index.html file. # This lets us use the new history APIs in the browser. @simple_page.route('/', defaults={'path': ''}) @@ -165,5 +164,3 @@ def add_header(r): # r.headers["Expires"] = "0" # r.headers['Cache-Control'] = 'public, max-age=0' return r - - diff --git a/backend/requirements.txt b/backend/requirements.txt deleted file mode 100644 index feabc7f..0000000 --- a/backend/requirements.txt +++ /dev/null @@ -1,18 +0,0 @@ -aniso8601==4.1.0 -certifi==2018.11.29 -chardet==3.0.4 -Click==7.0 -Flask==1.0.2 -flask-restplus==0.13.0 -Flask-SQLAlchemy==2.3.2 -idna==2.8 -itsdangerous==1.1.0 -Jinja2==2.10 -jsonschema==2.6.0 -MarkupSafe==1.1.0 -pytz==2018.9 -requests==2.21.0 -six==1.12.0 -SQLAlchemy==1.3.0 -urllib3==1.24.1 -Werkzeug==0.14.1 \ No newline at end of file diff --git a/backend/utils.py b/backend/utils.py index 2a71fa4..3b0fa76 100644 --- a/backend/utils.py +++ b/backend/utils.py @@ -1,568 +1,9 @@ import datetime -import json import os import time -from collections import OrderedDict -import sqlalchemy from flask import request -center_table = 'Sequence' -center_table_id = 'sequence_id' - -# the view order definitions -views = { - 'biological_v': [center_table, 'Virus'], - 'biological_h': [center_table, 'HostSample'], - 'technological': [center_table, 'ExperimentType'], - 'organizational': [center_table, 'SequencingProject'], - 'analytical_a': [center_table, 'Annotation', 'AminoacidVariant'], - 'analytical_impact': [center_table, 'NucleotideVariantAnnotated', 'VariantImpact'], - 'view_annotation': [center_table, 'AnnotationView'], - -} - - -def get_view(table): - if table == "Sequence": - return "technological" - for view_name, view_tables in views.items(): - if table in view_tables: - return view_name - - -class Column: - - def __init__(self, table_name, column_name, column_type, has_tid=False, description="", title=None, - is_numerical=False, is_date=False): - self.table_name = table_name - self.column_name = column_name - self.column_type = column_type - self.has_tid = has_tid - self.description = description - self.title = title - self.view = get_view(table_name) - self.is_numerical = is_numerical - self.is_date = is_date - - def var_table(self): - return var_table(self.table_name) - - def var_column(self): - return self.column_name[:2].lower() - - def __str__(self): - return str(self.__dict__) - - def __repr__(self): - return str(self.__dict__) - - -def var_table(table_name): - return table_name[:2].lower() - - -def unfold_list(res): - return [item for sublist in res for item in sublist] - - -def calc_distance(view_name, pre_table, table_name): - view = views[view_name] - if view_name == 'analytical_a': - return 2 - return view.index(table_name) - view.index(pre_table) - - -columns = [ - # technological - Column('Sequence', 'is_reference', bool, False, - "True when the sequence is the reference one (from RefSeq) for the virus species, False when the sequence is not the reference one"), - Column('Sequence', 'is_complete', bool, False, - "True when the sequence is complete, False when the sequence is partial. When not available from original source, " - "we set False if its length is less than 95% of the reference sequence length, otherwise we set N/D since completeness cannot be determined with needed accuracy."), - Column('Sequence', 'strand', str, False, "Strand to which the sequence belongs to (either positive or negative)"), - Column('Sequence', 'length', int, False, "Number of nucleotides of the sequence", "Sequence Length", - is_numerical=True), - Column('Sequence', 'gc_percentage', float, False, "Percentage of read G and C bases", "GC%", is_numerical=True), - Column('Sequence', 'n_percentage', float, False, "Percentage of unknown bases", "N%", is_numerical=True), - Column('Sequence', 'lineage', str, False, "Sequence lineage derived from source (for COG-UK) or calculated with the Pangolin software https://cov-lineages.org/pangolin.html (for other sources)"), - - Column('ExperimentType', 'sequencing_technology', str, False, "Platform used for the sequencing experiment"), - Column('ExperimentType', 'assembly_method', str, False, - "Algorithms applied to obtain the final sequence (e.g., for reads assembly, reads alignment, variant calling)"), - Column('ExperimentType', 'coverage', int, False, - "Number of unique reads that include a specific nucleotide in the reconstructed sequence", - is_numerical=True), - - # organizational - Column('SequencingProject', 'sequencing_lab', str, False, - "Laboratory that sequenced and submitted the sequence to the databank (encoded by \'Database source\')", - "Submitting Lab"), - Column('SequencingProject', 'submission_date', datetime, False, - "Date of submission of the sequence to the databank (encoded by \'Database source\')", - is_date=True), - Column('SequencingProject', 'bioproject_id', str, False, - "External reference to the NCBI BioProject database https://www.ncbi.nlm.nih.gov/bioproject/", - "BioProject ID"), - Column('SequencingProject', 'database_source', str, False, "Original database from which information is collected"), - - # biological - Column('Virus', 'taxon_id', int, False, - "Virus numerical id as to the NCBI Taxonomy https://www.ncbi.nlm.nih.gov/taxonomy", "Virus taxon ID"), - Column('Virus', 'taxon_name', str, False, - "Virus name as to the NCBI Taxonomy https://www.ncbi.nlm.nih.gov/taxonomy", "Virus taxon name"), - Column('Virus', 'species', str, False, - "Virus species name as to the NCBI Taxonomy https://www.ncbi.nlm.nih.gov/taxonomy", "Virus species"), - - Column('HostSample', 'host_taxon_name', str, False, - "Host organism species name from NCBI Taxonomy https://www.ncbi.nlm.nih.gov/taxonomy", "Host taxon name"), - Column('HostSample', 'collection_date', datetime, False, - "Date in which the infected biological sample was collected", is_date=True), - Column('HostSample', 'isolation_source', str, False, - "Tissue from which the infected biological sample was collected"), - Column('HostSample', 'geo_group', str, False, "Continent where the biological sample was collected", "Continent"), - Column('HostSample', 'country', str, False, "Country where the biological sample was collected"), - Column('HostSample', 'region', str, False, - "Region (i.e., part of country) where the biological sample was collected"), - Column('HostSample', 'gender', str, False, "Host organism gender (when applicable)"), - Column('HostSample', 'age', int, False, "Host organism age (in years, when applicable) ", is_numerical=True), -] - -columns_item = [ - Column('Sequence', 'accession_id', str, False, "Sequence unique identifier, from original source database", - "Accession ID"), - Column('Sequence', 'strain_name', str, False, - "Virus strain name (sometimes hard-coding relevant information such as the species, collection location and date)"), - - # Column('Sequence', 'nucleotide_sequence', str, False, ""), - Column('Sequence', 'clade', str, False, "Sequence-clade description"), - Column('HostSample', 'host_taxon_id', int, False, "HostSample-host_taxon_id description"), - Column('HostSample', 'originating_lab', str, False, "HostSample-originating_lab description"), - Column('Virus', 'genus', str, False, "Virus-genus description"), - Column('Virus', 'sub_family', str, False, "Virus-sub_family description"), - Column('Virus', 'family', str, False, "Virus-family description"), - Column('Virus', 'equivalent_list', str, False, "Virus-equivalent_list description"), - Column('Virus', 'molecule_type', str, False, "Virus-molecule_type description"), - Column('Virus', 'is_single_stranded', str, False, "Virus-is_single_stranded description"), - Column('Virus', 'is_positive_stranded', str, False, "Virus-is_positive_stranded description"), - - Column('AnnotationView', 'aminoacid_sequence', str, False, - "Virus-is_positive_stranded description"), - Column('AnnotationView', 'annotation_nucleotide_sequence', str, False, - "Virus-is_positive_stranded description"), -] - -columns_others = [ - Column('Annotation', 'gene_name', str, False, "Annotation-gene_name description"), - Column('Annotation', 'product', str, False, "Annotation-product description"), - - Column('AminoacidVariant', 'variant_aa_type', str, False, "Annotation-variant_aa_type description"), - Column('AminoacidVariant', 'sequence_aa_original', str, False, "Annotation-sequence_aa_original description"), - Column('AminoacidVariant', 'sequence_aa_alternative', str, False, "Annotation-sequence_aa_alternative description"), - # Column('AminoacidVariant', 'aa_position', int, False, "AminoacidVariant-aa_position"), - Column('AminoacidVariant', 'start_aa_original', int, False, "AminoacidVariant-start_aa_original"), - - Column('NucleotideVariantAnnotated', 'sequence_original', str, False, - "NucleotideVariant-sequence_original description"), - Column('NucleotideVariantAnnotated', 'sequence_alternative', str, False, - "NucleotideVariant-sequence_alternative description"), - Column('NucleotideVariantAnnotated', 'variant_type', str, False, - "NucleotideVariant-variant_type description"), - # Column('NucleotideVariant', 'var_position', int, False, "NucleotideVariant-var_position"), - Column('NucleotideVariantAnnotated', 'start_original', int, False, "NucleotideVariant-var_position"), - Column('NucleotideVariantAnnotated', 'variant_length', int, False, "NucleotideVariant-variant_length"), - - Column('NucleotideVariantAnnotated', 'n_feature_type', str, False, - "NucleotideVariantAnnotation-n_feature_type description"), - Column('NucleotideVariantAnnotated', 'n_gene_name', str, False, - "NucleotideVariantAnnotation-n_gene_name description"), - Column('NucleotideVariantAnnotated', 'n_product', str, False, - "NucleotideVariantAnnotation-n_product description"), - - Column('VariantImpact', 'effect', str, False, - "VariantImpact-effect description"), - Column('VariantImpact', 'putative_impact', str, False, - "VariantImpact-putative_impact description"), - Column('VariantImpact', 'impact_gene_name', str, False, - "VariantImpact-impact_gene_name description"), - - Column('AnnotationView', 'annotation_view_product', str, False, "annotation_view_product description"), -] - -columns_dict = {x.column_name: x for x in columns} - -columns_dict_item = {x.column_name: x for x in columns + columns_item} - -columns_dict_all = {x.column_name: x for x in columns + columns_item + columns_others} - -del columns -del columns_item -del columns_others - -# TODO uncomment if there are replications on the management view, -# and create a query that takes care for different views -# TODO VIRUS -agg_tables = [] # views['biological'][1:] # +views['management'][1:] - - -def pair_query_resolver(pair_query, pair_key): - # print(pair_query) - where_temp_inner = [] - for name, val in pair_query.items(): - search_list = [ - ('Annotation', f"ann{pair_key}"), - ('AminoacidVariant', f"aa_var{pair_key}"), - ('NucleotideVariantAnnotated', f"n_var{pair_key}"), - ('VariantImpact', f"n_imp{pair_key}"), - ] - inner_table_name = '' - for t_name, t_alias in search_list: - if name in [x.column_name for x in columns_dict_all.values() if x.table_name == t_name]: - inner_table_name = t_alias - break - - if name == 'start_aa_original': - position_sub = [] - if 'min_val' in val: - position_sub.append(f" aa_var{pair_key}.start_aa_original >= {int(val['min_val'])} ") - if 'max_val' in val: - position_sub.append(f" aa_var{pair_key}.start_aa_original <= {int(val['max_val'])} ") - where_temp_inner.append(f" ({' AND '.join(position_sub)}) ") - elif name == 'start_original': - position_sub = [] - if 'min_val' in val: - position_sub.append(f" n_var{pair_key}.start_original >= {int(val['min_val'])} ") - if 'max_val' in val: - position_sub.append(f" n_var{pair_key}.start_original <= {int(val['max_val'])} ") - where_temp_inner.append(f" ({' AND '.join(position_sub)}) ") - elif name == 'variant_length': - variant_length_sub = [] - if 'min_val' in val: - variant_length_sub.append(f" n_var{pair_key}.variant_length >= {int(val['min_val'])} ") - if 'max_val' in val: - variant_length_sub.append(f" n_var{pair_key}.variant_length <= {int(val['max_val'])} ") - where_temp_inner.append(f" ({' AND '.join(variant_length_sub)}) ") - else: - inner_text_list = [] - if None in val: - inner_text_list.append(f" lower({inner_table_name}.{name}) IS NULL ") - vals = ",".join([f"'{x.lower()}'" for x in val if x]) - if vals: - inner_text_list.append(f" lower({inner_table_name}.{name}) IN ({vals}) ") - where_temp_inner.append("(" + " OR ".join(inner_text_list) + ")") - return "(" + " AND ".join(where_temp_inner) + ")" - - -def sql_query_generator(gcm_query, search_type, pairs_query, return_type, agg=False, field_selected="", limit=1000, - offset=0, order_col="accession_id", order_dir="ASC", rel_distance=3, panel=None, - annotation_type=None, external_where_conditions=[], with_nuc_seq = False, epitope_part=None, - epitope_table=None): - # TODO VIRUS PAIRS - # pairs = generate_where_pairs(pairs_query) - # pairs = generate_where_pairs({}) - pair_join = '' - pair_where = '' - pair_count = [] - - where_temp_outer_and = [] - # if pairs_query: - for pair_key, pair_value in pairs_query.items(): - # print("pair_key:", pair_key) - # print("pairs_query:", pairs_query) - type_query = pair_value['type_query'] - # print('type_query', type_query) - pair_queries = pair_value['query'] - # print('pair_queries', pair_queries) - - tables = set(y for x in pair_value['query'] for y in x.keys()) - if type_query == 'aa': - pair_count.append(f" COUNT(DISTINCT aa_var{pair_key}.aminoacid_variant_id) {pair_key}_count ") - pair_join += f" JOIN annotation as ann{pair_key} ON ann{pair_key}.sequence_id = it.sequence_id " - # if tables.intersection([x.column_name for x in columns_dict_all.values() if x.table_name == 'AminoacidVariant']): - pair_join += f" JOIN aminoacid_variant as aa_var{pair_key} ON aa_var{pair_key}.annotation_id = ann{pair_key}.annotation_id " - if type_query == 'nuc': - pair_count.append(f" COUNT(DISTINCT n_var{pair_key}.nucleotide_variant_id) {pair_key}_count ") - pair_join += f" JOIN nucleotide_variant_annotated as n_var{pair_key} ON n_var{pair_key}.sequence_id = it.sequence_id " - if tables.intersection( - [x.column_name for x in columns_dict_all.values() if x.table_name == 'VariantImpact']): - pair_join += f" JOIN variant_impact as n_imp{pair_key} ON n_imp{pair_key}.nucleotide_variant_id = n_imp{pair_key}.nucleotide_variant_id " - - where_temp_outer_or = [] - for pair_query in pair_queries: - pair_query_res = pair_query_resolver(pair_query, pair_key) - where_temp_outer_or.append(pair_query_res) - where_temp_outer_and.append("(" + " OR ".join(where_temp_outer_or) + ")") - - pair_where += " AND ".join(where_temp_outer_and) - - print('pair_join: ', pair_join) - print('pair_where: ', pair_where) - - select_part = "" - from_part = "" - item = " FROM sequence it " - # dataset_join = " join dataset da on it.dataset_id = da.dataset_id " - - if with_nuc_seq: - item += " NATURAL JOIN nucleotide_sequence as nuc_seq" - - experiment_type_join = " join experiment_type ex on it.experiment_type_id = ex.experiment_type_id" - - sequencing_project_join = " join sequencing_project sp on it.sequencing_project_id = sp.sequencing_project_id" - - host_sample_join = " join host_sample_view hs on it.host_sample_id = hs.host_sample_id" - - virus_join = " join virus v on it.virus_id = v.virus_id" - - annotation_join = " JOIN annotation as ann ON it.sequence_id = ann.sequence_id " - - aminoacid_variant_join = " JOIN aminoacid_variant as aa_var ON aa_var.annotation_id = ann.annotation_id " - - nucleotide_variant_join = " JOIN nucleotide_variant_annotated as n_var ON it.sequence_id = n_var.sequence_id " - - nucleotide_variant_impact = " JOIN variant_impact as n_imp ON n_var.nucleotide_variant_id = n_imp.nucleotide_variant_id " - - annotation_view_join = " JOIN annotation_sequence as ann_view ON it.sequence_id = ann_view.sequence_id " - - view_join = { - # TODO VIRUS - 'biological_h': [host_sample_join], - 'biological_v': [virus_join], - 'organizational': [sequencing_project_join], - 'technological': [experiment_type_join], - 'analytical_a': [annotation_join, aminoacid_variant_join], - 'analytical_impact': [nucleotide_variant_join, nucleotide_variant_impact], - 'view_annotation': [annotation_view_join], - } - - if field_selected != "" or return_type == 'item_id': - columns = [x for x in gcm_query.keys()] - if field_selected != "": - columns.append(field_selected) - if panel: - for key_panel in panel: - columns.append(key_panel) - tables = [columns_dict_all[x].table_name for x in columns] - joins = [] - for table in tables: - # table = columns_dict_item[field_selected].table_name - view = get_view(table) - index = calc_distance(view, center_table, table) - joins += view_join[view][:index] - joins = list(OrderedDict.fromkeys(joins)) - from_part = item + " ".join(joins) + pair_join - else: - from_part = item + experiment_type_join + sequencing_project_join + host_sample_join + virus_join + pair_join - if annotation_type: - annotation_type = annotation_type.replace("'", "''") - from_part = from_part + annotation_view_join + f" AND lower(ann_view.product) = lower('{annotation_type}')" - - gcm_where = generate_where_sql(gcm_query, search_type, rel_distance=rel_distance, epitope_part=epitope_part, epitope_table=epitope_table) - - panel_where = '' - if panel: - panel_where = pair_query_resolver(panel, '') - - where_part = "" - where_list = [x for x in [gcm_where, pair_where, panel_where] + external_where_conditions if x] - - if where_list: - where_part = " WHERE " + " AND ".join(where_list) - - # print("where_part:", where_part) - for i, wp in enumerate(where_list): - print(f"where_sub_part({i}):", wp) - - sub_where_part = "" - group_by_part = "" - limit_part = "" - offset_part = "" - order_by = "" - if return_type == 'table': - if annotation_type: - select_columns = columns_dict_item.keys() - else: - select_columns = (key for key, value in columns_dict_item.items() if value.table_name != 'AnnotationView') - - all_columns = "it.sequence_id, " + ', '.join(select_columns) + " " - select_part = "SELECT " + ("max(nuc_seq.nucleotide_sequence) as nucleotide_sequence, " if with_nuc_seq else "") + all_columns - if pair_count: - select_part += ',' + ','.join(pair_count) - - group_by_part = " GROUP BY " + all_columns - del all_columns - - if limit: - limit_part = f" LIMIT {limit} " - if offset: - offset_part = f"OFFSET {offset} " - order_by = f" ORDER BY {order_col} {order_dir} " - - elif return_type == 'allInfo': - select_part = " SELECT * " - - elif return_type == 'allInfoCustomEpi': - select_part = " SELECT distinct it.*, ex.*, sp.*, hs.*, v.*, annaa_0.*, aa_varaa_0.* " - - elif return_type == 'field_value': - # TODO add new.... - if columns_dict_all[field_selected].table_name == 'Annotation': - field_selected_new = "ann." + field_selected - elif columns_dict_all[field_selected].table_name == 'AminoacidVariant': - field_selected_new = "aa_var." + field_selected - elif columns_dict_all[field_selected].table_name == 'NucleotideVariantAnnotated': - field_selected_new = "n_var." + field_selected - elif columns_dict_all[field_selected].table_name == 'VariantImpact': - field_selected_new = "n_imp." + field_selected - elif field_selected == "annotation_view_product": - field_selected_new ="ann_view.product" - else: - field_selected_new = field_selected - - col = columns_dict_all[field_selected] - column_type = col.column_type - lower_pre = 'LOWER(' if column_type == str else '' - lower_post = ')' if column_type == str else '' - distinct = "" - # if search_type == 'original': - distinct = "distinct" - select_part = f"SELECT {distinct} {lower_pre}{field_selected_new}{lower_post} as label, it.{center_table_id} as item " - - elif return_type == 'item_id': - select_part = f"SELECT DISTINCT it.{center_table_id} " - - elif return_type == 'count_variants': - select_part = f"SELECT distinct aa_varaa_0.aminoacid_variant_id, aa_varaa_0.variant_aa_length " - - full_query = select_part + from_part + where_part + sub_where_part + group_by_part + order_by + limit_part + offset_part - print(full_query) - return full_query - - -def generate_where_sql(gcm_query, search_type, rel_distance=3, epitope_part=None, epitope_table=None): - sub_where = [] - where_part = "" - if gcm_query: - where_part = " (" - - for (column, values) in gcm_query.items(): - col = columns_dict_item[column] - column_type = col.column_type - lower_pre = 'LOWER(' if column_type == str else '' - lower_post = ')' if column_type == str else '' - syn_sub_where = [] - - if search_type == 'synonym' and col.has_tid: - syn_sub_where = [f"{col.column_name}_tid in (SELECT tid FROM synonym WHERE LOWER(label) = LOWER('{value}'))" - for - value in values - if value is not None] - elif search_type == 'expanded' and col.has_tid: - syn_sub_where = [f"{col.column_name}_tid in (SELECT tid_descendant " - f"FROM relationship_unfolded WHERE distance <= {rel_distance} and tid_ancestor in " - f"(SELECT tid FROM synonym WHERE LOWER(label) = LOWER('{value}')))" for - value in values - if value is not None] - if col.is_numerical or col.is_date: - - min = values.get('min_val') - max = values.get('max_val') - isNull = values.get('is_null') - a = "" - - if min is not None: - if col.is_date: - a += f" {col.column_name} >= '{min}' " - else: - a += f" {col.column_name} >= {min} " - - if max is not None: - if a: - a += ' and ' - if col.is_date: - a += f" {col.column_name} <= '{max}' " - else: - a += f" {col.column_name} <= {max} " - - if isNull: - if a: - a += ' or ' - a += f" {col.column_name} is null " - - if not a: - a += ' TRUE ' - - sub_where.append(a) - - else: - sub_sub_where = [f"{lower_pre}{column}{lower_post} = '{value}'" for value in values if value is not None] - sub_sub_where_none = [f"{column} IS NULL" for value in values if value is None] - sub_sub_where.extend(sub_sub_where_none) - sub_sub_where.extend(syn_sub_where) - sub_where.append(" OR ".join(sub_sub_where)) - - if gcm_query: - where_part += ") AND (".join(sub_where) + ")" - - if epitope_part is not None: - where_part += f""" and it.sequence_id IN (SELECT distinct sequence_id - FROM {epitope_table} as epic {epitope_part}) """ - return where_part - - -def generate_where_pairs(pair_query): - searched = pair_query.keys() - - pair_join = [] - - where = [] - i = 0 - for x in searched: - kv = "kv_" + str(i) - i += 1 - join = f" join unified_pair {kv} on it.{center_table_id} = {kv}.{center_table_id} " - pair_join.append(join) - items = pair_query[x]['query'] - gcm = items['gcm'] - pair = items['pairs'] - - sub_where = [] - - for k in gcm.keys(): - a = "" - a += f" lower({kv}.key) = lower('{k}') and {kv}.is_gcm = true and " - values = gcm[k] - sub_sub_where = [] - for value in values: - v = value.replace("'", "''") - sub_sub_where.append(f"lower({kv}.value) = lower('{v}')") - a += ("(" + " OR ".join(sub_sub_where) + ")") - - # print(a) - sub_where.append(a) - - for k in pair.keys(): - a = "" - a += f" lower({kv}.key) = lower('{k}') and {kv}.is_gcm = false and " - values = pair[k] - sub_sub_where = [] - for value in values: - v = value.replace("'", "''") - sub_sub_where.append(f"lower({kv}.value) = lower('{v}')") - a += ("(" + " OR ".join(sub_sub_where) + ")") - - # print(a) - sub_where.append(a) - - where.append("(" + ") OR (".join(sub_where) + ")") - - where_part = "" - if pair_query: - where_part = "(" + ") AND (".join(where) + ")" - - return {'where': where_part, 'join': " ".join(pair_join)} - - # IP ADDRESS AND QUERY LOGGING ROOT_DIR = os.path.dirname(os.getcwd()) @@ -609,120 +50,3 @@ def ip_info(addr=''): # will print the data line by line print(attr, ' ' * 13 + '\t->\t', data[attr]) print(data) - - -taxon_name_dict = {} -taxon_id_dict = {} - - -def load_viruses(): - from app import my_app - from model.models import db - try: - import json - with open("viz_color.json", "r") as f: - product_colors = json.load(f) - product_colors = {int(key): val for key, val in product_colors.items()} - except: - product_colors = {} - with my_app.app_context(): - query = sql_query_generator({"is_reference": [True]}, "original", {}, 'table', limit=None) - pre_query = db.engine.execute(sqlalchemy.text(query)) - # return_columns = pre_query._metadata.keys - # print(return_columns) - res = pre_query.fetchall() - for row in res: - row_dict = dict(row) - taxon_name = row_dict['taxon_name'].lower() - taxon_id = row_dict['taxon_id'] - # add two empty lists (AA and nuc) to use below - row_dict.update({#'nucleotide_sequence_length': len(row_dict['nucleotide_sequence']), - "a_products": list(), - "n_products": list(), }) - - row_dict = {k: v for k, v in row_dict.items() if k in ["taxon_id", - "taxon_name", - "a_products", - "n_products", - # "nucleotide_sequence_length", - ]} - taxon_name_dict[taxon_name] = row_dict - taxon_id_dict[taxon_id] = row_dict - - query = """ - SELECT *, - MIN(start) OVER(PARTITION BY gene_name) = start AND - MAX(stop) OVER(PARTITION BY gene_name) = stop as is_gene - FROM virus - NATURAL JOIN sequence - NATURAL JOIN annotation - NATURAL LEFT JOIN annotation_sequence - WHERE is_reference - ORDER BY virus_id, gene_name - """ - pre_query = db.engine.execute(sqlalchemy.text(query)) - # return_columns = pre_query._metadata.keys - # print(return_columns) - res = pre_query.fetchall() - for row in res: - row_dict = dict(row) - taxon_id = row_dict['taxon_id'] - product = row_dict["product"] - - a_new_product = { - "name": product, - "start": row_dict["start"], - "end": row_dict["stop"], - "row": 0, - "sequence": row_dict["aminoacid_sequence"], - } - if taxon_id in product_colors and product in product_colors[taxon_id]: - a_new_product.update({'color': product_colors[taxon_id][product]}) - - taxon_id_dict[taxon_id]["a_products"].append(a_new_product) - - if row_dict["is_gene"]: - n_new_product = { - "name": row_dict["gene_name"], - "start": row_dict["start"], - "end": row_dict["stop"], - "row": 0, - } - taxon_id_dict[taxon_id]["n_products"].append(n_new_product) - - -connection_dict = {} - - -def custom_db_execution(query, poll_id): - from threading import Timer - from app import my_app - from model.models import db - - with db.engine.connect() as connection: - - def drop(): - forget_connection(poll_id, connection) - - save_connection(poll_id, connection) - t = Timer(5.0, drop) - t.start() - pre_query = connection.execute(query) - results = pre_query.fetchall() - connection.close() - #forget_connection(poll_id, connection) - return results - - -def save_connection(poll_id, connection): - new_connection = { - "poll_id": poll_id, - "connection": connection - } - new_connection_line = dict(new_connection) - connection_dict[poll_id] = new_connection_line - - -def forget_connection(poll_id, conn): - #conn.close() - connection_dict.pop(poll_id) diff --git a/frontend/dist/favicon.ico b/frontend/dist/favicon.ico index df36fcf..979ec9c 100644 Binary files a/frontend/dist/favicon.ico and b/frontend/dist/favicon.ico differ diff --git a/frontend/dist/index.html b/frontend/dist/index.html index 058dc9e..e247523 100644 --- a/frontend/dist/index.html +++ b/frontend/dist/index.html @@ -1 +1 @@ -Webpack App
\ No newline at end of file +Proj
\ No newline at end of file diff --git a/frontend/dist/static/css/chunk-vendors.2a8ac01d.css b/frontend/dist/static/css/chunk-vendors.2a8ac01d.css deleted file mode 100644 index 80f297d..0000000 --- a/frontend/dist/static/css/chunk-vendors.2a8ac01d.css +++ /dev/null @@ -1,5 +0,0 @@ -.container{width:100%;padding:12px;margin-right:auto;margin-left:auto}@media(min-width:960px){.container{max-width:900px}}@media(min-width:1264px){.container{max-width:1185px}}@media(min-width:1904px){.container{max-width:1785px}}.container--fluid{max-width:100%}.row{display:flex;flex-wrap:wrap;flex:1 1 auto;margin:-12px}.row+.row{margin-top:12px}.row+.row--dense{margin-top:4px}.row--dense{margin:-4px}.row--dense>.col,.row--dense>[class*=col-]{padding:4px}.row.no-gutters{margin:0}.row.no-gutters>.col,.row.no-gutters>[class*=col-]{padding:0}.col,.col-1,.col-2,.col-3,.col-4,.col-5,.col-6,.col-7,.col-8,.col-9,.col-10,.col-11,.col-12,.col-auto,.col-lg,.col-lg-1,.col-lg-2,.col-lg-3,.col-lg-4,.col-lg-5,.col-lg-6,.col-lg-7,.col-lg-8,.col-lg-9,.col-lg-10,.col-lg-11,.col-lg-12,.col-lg-auto,.col-md,.col-md-1,.col-md-2,.col-md-3,.col-md-4,.col-md-5,.col-md-6,.col-md-7,.col-md-8,.col-md-9,.col-md-10,.col-md-11,.col-md-12,.col-md-auto,.col-sm,.col-sm-1,.col-sm-2,.col-sm-3,.col-sm-4,.col-sm-5,.col-sm-6,.col-sm-7,.col-sm-8,.col-sm-9,.col-sm-10,.col-sm-11,.col-sm-12,.col-sm-auto,.col-xl,.col-xl-1,.col-xl-2,.col-xl-3,.col-xl-4,.col-xl-5,.col-xl-6,.col-xl-7,.col-xl-8,.col-xl-9,.col-xl-10,.col-xl-11,.col-xl-12,.col-xl-auto{width:100%;padding:12px}.col{flex-basis:0;flex-grow:1;max-width:100%}.col-auto{flex:0 0 auto;width:auto;max-width:100%}.col-1{flex:0 0 8.3333333333%;max-width:8.3333333333%}.col-2{flex:0 0 16.6666666667%;max-width:16.6666666667%}.col-3{flex:0 0 25%;max-width:25%}.col-4{flex:0 0 33.3333333333%;max-width:33.3333333333%}.col-5{flex:0 0 41.6666666667%;max-width:41.6666666667%}.col-6{flex:0 0 50%;max-width:50%}.col-7{flex:0 0 58.3333333333%;max-width:58.3333333333%}.col-8{flex:0 0 66.6666666667%;max-width:66.6666666667%}.col-9{flex:0 0 75%;max-width:75%}.col-10{flex:0 0 83.3333333333%;max-width:83.3333333333%}.col-11{flex:0 0 91.6666666667%;max-width:91.6666666667%}.col-12{flex:0 0 100%;max-width:100%}.v-application--is-ltr .offset-1{margin-left:8.3333333333%}.v-application--is-rtl .offset-1{margin-right:8.3333333333%}.v-application--is-ltr .offset-2{margin-left:16.6666666667%}.v-application--is-rtl .offset-2{margin-right:16.6666666667%}.v-application--is-ltr .offset-3{margin-left:25%}.v-application--is-rtl .offset-3{margin-right:25%}.v-application--is-ltr .offset-4{margin-left:33.3333333333%}.v-application--is-rtl .offset-4{margin-right:33.3333333333%}.v-application--is-ltr .offset-5{margin-left:41.6666666667%}.v-application--is-rtl .offset-5{margin-right:41.6666666667%}.v-application--is-ltr .offset-6{margin-left:50%}.v-application--is-rtl .offset-6{margin-right:50%}.v-application--is-ltr .offset-7{margin-left:58.3333333333%}.v-application--is-rtl .offset-7{margin-right:58.3333333333%}.v-application--is-ltr .offset-8{margin-left:66.6666666667%}.v-application--is-rtl .offset-8{margin-right:66.6666666667%}.v-application--is-ltr .offset-9{margin-left:75%}.v-application--is-rtl .offset-9{margin-right:75%}.v-application--is-ltr .offset-10{margin-left:83.3333333333%}.v-application--is-rtl .offset-10{margin-right:83.3333333333%}.v-application--is-ltr .offset-11{margin-left:91.6666666667%}.v-application--is-rtl .offset-11{margin-right:91.6666666667%}@media(min-width:600px){.col-sm{flex-basis:0;flex-grow:1;max-width:100%}.col-sm-auto{flex:0 0 auto;width:auto;max-width:100%}.col-sm-1{flex:0 0 8.3333333333%;max-width:8.3333333333%}.col-sm-2{flex:0 0 16.6666666667%;max-width:16.6666666667%}.col-sm-3{flex:0 0 25%;max-width:25%}.col-sm-4{flex:0 0 33.3333333333%;max-width:33.3333333333%}.col-sm-5{flex:0 0 41.6666666667%;max-width:41.6666666667%}.col-sm-6{flex:0 0 50%;max-width:50%}.col-sm-7{flex:0 0 58.3333333333%;max-width:58.3333333333%}.col-sm-8{flex:0 0 66.6666666667%;max-width:66.6666666667%}.col-sm-9{flex:0 0 75%;max-width:75%}.col-sm-10{flex:0 0 83.3333333333%;max-width:83.3333333333%}.col-sm-11{flex:0 0 91.6666666667%;max-width:91.6666666667%}.col-sm-12{flex:0 0 100%;max-width:100%}.v-application--is-ltr .offset-sm-0{margin-left:0}.v-application--is-rtl .offset-sm-0{margin-right:0}.v-application--is-ltr .offset-sm-1{margin-left:8.3333333333%}.v-application--is-rtl .offset-sm-1{margin-right:8.3333333333%}.v-application--is-ltr .offset-sm-2{margin-left:16.6666666667%}.v-application--is-rtl .offset-sm-2{margin-right:16.6666666667%}.v-application--is-ltr .offset-sm-3{margin-left:25%}.v-application--is-rtl .offset-sm-3{margin-right:25%}.v-application--is-ltr .offset-sm-4{margin-left:33.3333333333%}.v-application--is-rtl .offset-sm-4{margin-right:33.3333333333%}.v-application--is-ltr .offset-sm-5{margin-left:41.6666666667%}.v-application--is-rtl .offset-sm-5{margin-right:41.6666666667%}.v-application--is-ltr .offset-sm-6{margin-left:50%}.v-application--is-rtl .offset-sm-6{margin-right:50%}.v-application--is-ltr .offset-sm-7{margin-left:58.3333333333%}.v-application--is-rtl .offset-sm-7{margin-right:58.3333333333%}.v-application--is-ltr .offset-sm-8{margin-left:66.6666666667%}.v-application--is-rtl .offset-sm-8{margin-right:66.6666666667%}.v-application--is-ltr .offset-sm-9{margin-left:75%}.v-application--is-rtl .offset-sm-9{margin-right:75%}.v-application--is-ltr .offset-sm-10{margin-left:83.3333333333%}.v-application--is-rtl .offset-sm-10{margin-right:83.3333333333%}.v-application--is-ltr .offset-sm-11{margin-left:91.6666666667%}.v-application--is-rtl .offset-sm-11{margin-right:91.6666666667%}}@media(min-width:960px){.col-md{flex-basis:0;flex-grow:1;max-width:100%}.col-md-auto{flex:0 0 auto;width:auto;max-width:100%}.col-md-1{flex:0 0 8.3333333333%;max-width:8.3333333333%}.col-md-2{flex:0 0 16.6666666667%;max-width:16.6666666667%}.col-md-3{flex:0 0 25%;max-width:25%}.col-md-4{flex:0 0 33.3333333333%;max-width:33.3333333333%}.col-md-5{flex:0 0 41.6666666667%;max-width:41.6666666667%}.col-md-6{flex:0 0 50%;max-width:50%}.col-md-7{flex:0 0 58.3333333333%;max-width:58.3333333333%}.col-md-8{flex:0 0 66.6666666667%;max-width:66.6666666667%}.col-md-9{flex:0 0 75%;max-width:75%}.col-md-10{flex:0 0 83.3333333333%;max-width:83.3333333333%}.col-md-11{flex:0 0 91.6666666667%;max-width:91.6666666667%}.col-md-12{flex:0 0 100%;max-width:100%}.v-application--is-ltr .offset-md-0{margin-left:0}.v-application--is-rtl .offset-md-0{margin-right:0}.v-application--is-ltr .offset-md-1{margin-left:8.3333333333%}.v-application--is-rtl .offset-md-1{margin-right:8.3333333333%}.v-application--is-ltr .offset-md-2{margin-left:16.6666666667%}.v-application--is-rtl .offset-md-2{margin-right:16.6666666667%}.v-application--is-ltr .offset-md-3{margin-left:25%}.v-application--is-rtl .offset-md-3{margin-right:25%}.v-application--is-ltr .offset-md-4{margin-left:33.3333333333%}.v-application--is-rtl .offset-md-4{margin-right:33.3333333333%}.v-application--is-ltr .offset-md-5{margin-left:41.6666666667%}.v-application--is-rtl .offset-md-5{margin-right:41.6666666667%}.v-application--is-ltr .offset-md-6{margin-left:50%}.v-application--is-rtl .offset-md-6{margin-right:50%}.v-application--is-ltr .offset-md-7{margin-left:58.3333333333%}.v-application--is-rtl .offset-md-7{margin-right:58.3333333333%}.v-application--is-ltr .offset-md-8{margin-left:66.6666666667%}.v-application--is-rtl .offset-md-8{margin-right:66.6666666667%}.v-application--is-ltr .offset-md-9{margin-left:75%}.v-application--is-rtl .offset-md-9{margin-right:75%}.v-application--is-ltr .offset-md-10{margin-left:83.3333333333%}.v-application--is-rtl .offset-md-10{margin-right:83.3333333333%}.v-application--is-ltr .offset-md-11{margin-left:91.6666666667%}.v-application--is-rtl .offset-md-11{margin-right:91.6666666667%}}@media(min-width:1264px){.col-lg{flex-basis:0;flex-grow:1;max-width:100%}.col-lg-auto{flex:0 0 auto;width:auto;max-width:100%}.col-lg-1{flex:0 0 8.3333333333%;max-width:8.3333333333%}.col-lg-2{flex:0 0 16.6666666667%;max-width:16.6666666667%}.col-lg-3{flex:0 0 25%;max-width:25%}.col-lg-4{flex:0 0 33.3333333333%;max-width:33.3333333333%}.col-lg-5{flex:0 0 41.6666666667%;max-width:41.6666666667%}.col-lg-6{flex:0 0 50%;max-width:50%}.col-lg-7{flex:0 0 58.3333333333%;max-width:58.3333333333%}.col-lg-8{flex:0 0 66.6666666667%;max-width:66.6666666667%}.col-lg-9{flex:0 0 75%;max-width:75%}.col-lg-10{flex:0 0 83.3333333333%;max-width:83.3333333333%}.col-lg-11{flex:0 0 91.6666666667%;max-width:91.6666666667%}.col-lg-12{flex:0 0 100%;max-width:100%}.v-application--is-ltr .offset-lg-0{margin-left:0}.v-application--is-rtl .offset-lg-0{margin-right:0}.v-application--is-ltr .offset-lg-1{margin-left:8.3333333333%}.v-application--is-rtl .offset-lg-1{margin-right:8.3333333333%}.v-application--is-ltr .offset-lg-2{margin-left:16.6666666667%}.v-application--is-rtl .offset-lg-2{margin-right:16.6666666667%}.v-application--is-ltr .offset-lg-3{margin-left:25%}.v-application--is-rtl .offset-lg-3{margin-right:25%}.v-application--is-ltr .offset-lg-4{margin-left:33.3333333333%}.v-application--is-rtl .offset-lg-4{margin-right:33.3333333333%}.v-application--is-ltr .offset-lg-5{margin-left:41.6666666667%}.v-application--is-rtl .offset-lg-5{margin-right:41.6666666667%}.v-application--is-ltr .offset-lg-6{margin-left:50%}.v-application--is-rtl .offset-lg-6{margin-right:50%}.v-application--is-ltr .offset-lg-7{margin-left:58.3333333333%}.v-application--is-rtl .offset-lg-7{margin-right:58.3333333333%}.v-application--is-ltr .offset-lg-8{margin-left:66.6666666667%}.v-application--is-rtl .offset-lg-8{margin-right:66.6666666667%}.v-application--is-ltr .offset-lg-9{margin-left:75%}.v-application--is-rtl .offset-lg-9{margin-right:75%}.v-application--is-ltr .offset-lg-10{margin-left:83.3333333333%}.v-application--is-rtl .offset-lg-10{margin-right:83.3333333333%}.v-application--is-ltr .offset-lg-11{margin-left:91.6666666667%}.v-application--is-rtl .offset-lg-11{margin-right:91.6666666667%}}@media(min-width:1904px){.col-xl{flex-basis:0;flex-grow:1;max-width:100%}.col-xl-auto{flex:0 0 auto;width:auto;max-width:100%}.col-xl-1{flex:0 0 8.3333333333%;max-width:8.3333333333%}.col-xl-2{flex:0 0 16.6666666667%;max-width:16.6666666667%}.col-xl-3{flex:0 0 25%;max-width:25%}.col-xl-4{flex:0 0 33.3333333333%;max-width:33.3333333333%}.col-xl-5{flex:0 0 41.6666666667%;max-width:41.6666666667%}.col-xl-6{flex:0 0 50%;max-width:50%}.col-xl-7{flex:0 0 58.3333333333%;max-width:58.3333333333%}.col-xl-8{flex:0 0 66.6666666667%;max-width:66.6666666667%}.col-xl-9{flex:0 0 75%;max-width:75%}.col-xl-10{flex:0 0 83.3333333333%;max-width:83.3333333333%}.col-xl-11{flex:0 0 91.6666666667%;max-width:91.6666666667%}.col-xl-12{flex:0 0 100%;max-width:100%}.v-application--is-ltr .offset-xl-0{margin-left:0}.v-application--is-rtl .offset-xl-0{margin-right:0}.v-application--is-ltr .offset-xl-1{margin-left:8.3333333333%}.v-application--is-rtl .offset-xl-1{margin-right:8.3333333333%}.v-application--is-ltr .offset-xl-2{margin-left:16.6666666667%}.v-application--is-rtl .offset-xl-2{margin-right:16.6666666667%}.v-application--is-ltr .offset-xl-3{margin-left:25%}.v-application--is-rtl .offset-xl-3{margin-right:25%}.v-application--is-ltr .offset-xl-4{margin-left:33.3333333333%}.v-application--is-rtl .offset-xl-4{margin-right:33.3333333333%}.v-application--is-ltr .offset-xl-5{margin-left:41.6666666667%}.v-application--is-rtl .offset-xl-5{margin-right:41.6666666667%}.v-application--is-ltr .offset-xl-6{margin-left:50%}.v-application--is-rtl .offset-xl-6{margin-right:50%}.v-application--is-ltr .offset-xl-7{margin-left:58.3333333333%}.v-application--is-rtl .offset-xl-7{margin-right:58.3333333333%}.v-application--is-ltr .offset-xl-8{margin-left:66.6666666667%}.v-application--is-rtl .offset-xl-8{margin-right:66.6666666667%}.v-application--is-ltr .offset-xl-9{margin-left:75%}.v-application--is-rtl .offset-xl-9{margin-right:75%}.v-application--is-ltr .offset-xl-10{margin-left:83.3333333333%}.v-application--is-rtl .offset-xl-10{margin-right:83.3333333333%}.v-application--is-ltr .offset-xl-11{margin-left:91.6666666667%}.v-application--is-rtl .offset-xl-11{margin-right:91.6666666667%}}.container.grow-shrink-0{flex-grow:0;flex-shrink:0}.container.fill-height{align-items:center;display:flex;flex-wrap:wrap}.container.fill-height>.row{flex:1 1 100%;max-width:calc(100% + 24px)}.container.fill-height>.layout{height:100%;flex:1 1 auto}.container.fill-height>.layout.grow-shrink-0{flex-grow:0;flex-shrink:0}.container.grid-list-xs .layout .flex{padding:1px}.container.grid-list-xs .layout:only-child{margin:-1px}.container.grid-list-xs .layout:not(:only-child){margin:auto -1px}.container.grid-list-xs :not(:only-child) .layout:first-child{margin-top:-1px}.container.grid-list-xs :not(:only-child) .layout:last-child{margin-bottom:-1px}.container.grid-list-sm .layout .flex{padding:2px}.container.grid-list-sm .layout:only-child{margin:-2px}.container.grid-list-sm .layout:not(:only-child){margin:auto -2px}.container.grid-list-sm :not(:only-child) .layout:first-child{margin-top:-2px}.container.grid-list-sm :not(:only-child) .layout:last-child{margin-bottom:-2px}.container.grid-list-md .layout .flex{padding:4px}.container.grid-list-md .layout:only-child{margin:-4px}.container.grid-list-md .layout:not(:only-child){margin:auto -4px}.container.grid-list-md :not(:only-child) .layout:first-child{margin-top:-4px}.container.grid-list-md :not(:only-child) .layout:last-child{margin-bottom:-4px}.container.grid-list-lg .layout .flex{padding:8px}.container.grid-list-lg .layout:only-child{margin:-8px}.container.grid-list-lg .layout:not(:only-child){margin:auto -8px}.container.grid-list-lg :not(:only-child) .layout:first-child{margin-top:-8px}.container.grid-list-lg :not(:only-child) .layout:last-child{margin-bottom:-8px}.container.grid-list-xl .layout .flex{padding:12px}.container.grid-list-xl .layout:only-child{margin:-12px}.container.grid-list-xl .layout:not(:only-child){margin:auto -12px}.container.grid-list-xl :not(:only-child) .layout:first-child{margin-top:-12px}.container.grid-list-xl :not(:only-child) .layout:last-child{margin-bottom:-12px}.layout{display:flex;flex:1 1 auto;flex-wrap:nowrap;min-width:0}.layout.reverse{flex-direction:row-reverse}.layout.column{flex-direction:column}.layout.column.reverse{flex-direction:column-reverse}.layout.column>.flex{max-width:100%}.layout.wrap{flex-wrap:wrap}.layout.grow-shrink-0{flex-grow:0;flex-shrink:0}@media (min-width:0){.flex.xs12{flex-basis:100%;flex-grow:0;max-width:100%}.flex.order-xs12{order:12}.flex.xs11{flex-basis:91.6666666667%;flex-grow:0;max-width:91.6666666667%}.flex.order-xs11{order:11}.flex.xs10{flex-basis:83.3333333333%;flex-grow:0;max-width:83.3333333333%}.flex.order-xs10{order:10}.flex.xs9{flex-basis:75%;flex-grow:0;max-width:75%}.flex.order-xs9{order:9}.flex.xs8{flex-basis:66.6666666667%;flex-grow:0;max-width:66.6666666667%}.flex.order-xs8{order:8}.flex.xs7{flex-basis:58.3333333333%;flex-grow:0;max-width:58.3333333333%}.flex.order-xs7{order:7}.flex.xs6{flex-basis:50%;flex-grow:0;max-width:50%}.flex.order-xs6{order:6}.flex.xs5{flex-basis:41.6666666667%;flex-grow:0;max-width:41.6666666667%}.flex.order-xs5{order:5}.flex.xs4{flex-basis:33.3333333333%;flex-grow:0;max-width:33.3333333333%}.flex.order-xs4{order:4}.flex.xs3{flex-basis:25%;flex-grow:0;max-width:25%}.flex.order-xs3{order:3}.flex.xs2{flex-basis:16.6666666667%;flex-grow:0;max-width:16.6666666667%}.flex.order-xs2{order:2}.flex.xs1{flex-basis:8.3333333333%;flex-grow:0;max-width:8.3333333333%}.flex.order-xs1{order:1}.v-application--is-ltr .flex.offset-xs12{margin-left:100%}.v-application--is-rtl .flex.offset-xs12{margin-right:100%}.v-application--is-ltr .flex.offset-xs11{margin-left:91.6666666667%}.v-application--is-rtl .flex.offset-xs11{margin-right:91.6666666667%}.v-application--is-ltr .flex.offset-xs10{margin-left:83.3333333333%}.v-application--is-rtl .flex.offset-xs10{margin-right:83.3333333333%}.v-application--is-ltr .flex.offset-xs9{margin-left:75%}.v-application--is-rtl .flex.offset-xs9{margin-right:75%}.v-application--is-ltr .flex.offset-xs8{margin-left:66.6666666667%}.v-application--is-rtl .flex.offset-xs8{margin-right:66.6666666667%}.v-application--is-ltr .flex.offset-xs7{margin-left:58.3333333333%}.v-application--is-rtl .flex.offset-xs7{margin-right:58.3333333333%}.v-application--is-ltr .flex.offset-xs6{margin-left:50%}.v-application--is-rtl .flex.offset-xs6{margin-right:50%}.v-application--is-ltr .flex.offset-xs5{margin-left:41.6666666667%}.v-application--is-rtl .flex.offset-xs5{margin-right:41.6666666667%}.v-application--is-ltr .flex.offset-xs4{margin-left:33.3333333333%}.v-application--is-rtl .flex.offset-xs4{margin-right:33.3333333333%}.v-application--is-ltr .flex.offset-xs3{margin-left:25%}.v-application--is-rtl .flex.offset-xs3{margin-right:25%}.v-application--is-ltr .flex.offset-xs2{margin-left:16.6666666667%}.v-application--is-rtl .flex.offset-xs2{margin-right:16.6666666667%}.v-application--is-ltr .flex.offset-xs1{margin-left:8.3333333333%}.v-application--is-rtl .flex.offset-xs1{margin-right:8.3333333333%}.v-application--is-ltr .flex.offset-xs0{margin-left:0}.v-application--is-rtl .flex.offset-xs0{margin-right:0}}@media (min-width:600px){.flex.sm12{flex-basis:100%;flex-grow:0;max-width:100%}.flex.order-sm12{order:12}.flex.sm11{flex-basis:91.6666666667%;flex-grow:0;max-width:91.6666666667%}.flex.order-sm11{order:11}.flex.sm10{flex-basis:83.3333333333%;flex-grow:0;max-width:83.3333333333%}.flex.order-sm10{order:10}.flex.sm9{flex-basis:75%;flex-grow:0;max-width:75%}.flex.order-sm9{order:9}.flex.sm8{flex-basis:66.6666666667%;flex-grow:0;max-width:66.6666666667%}.flex.order-sm8{order:8}.flex.sm7{flex-basis:58.3333333333%;flex-grow:0;max-width:58.3333333333%}.flex.order-sm7{order:7}.flex.sm6{flex-basis:50%;flex-grow:0;max-width:50%}.flex.order-sm6{order:6}.flex.sm5{flex-basis:41.6666666667%;flex-grow:0;max-width:41.6666666667%}.flex.order-sm5{order:5}.flex.sm4{flex-basis:33.3333333333%;flex-grow:0;max-width:33.3333333333%}.flex.order-sm4{order:4}.flex.sm3{flex-basis:25%;flex-grow:0;max-width:25%}.flex.order-sm3{order:3}.flex.sm2{flex-basis:16.6666666667%;flex-grow:0;max-width:16.6666666667%}.flex.order-sm2{order:2}.flex.sm1{flex-basis:8.3333333333%;flex-grow:0;max-width:8.3333333333%}.flex.order-sm1{order:1}.v-application--is-ltr .flex.offset-sm12{margin-left:100%}.v-application--is-rtl .flex.offset-sm12{margin-right:100%}.v-application--is-ltr .flex.offset-sm11{margin-left:91.6666666667%}.v-application--is-rtl .flex.offset-sm11{margin-right:91.6666666667%}.v-application--is-ltr .flex.offset-sm10{margin-left:83.3333333333%}.v-application--is-rtl .flex.offset-sm10{margin-right:83.3333333333%}.v-application--is-ltr .flex.offset-sm9{margin-left:75%}.v-application--is-rtl .flex.offset-sm9{margin-right:75%}.v-application--is-ltr .flex.offset-sm8{margin-left:66.6666666667%}.v-application--is-rtl .flex.offset-sm8{margin-right:66.6666666667%}.v-application--is-ltr .flex.offset-sm7{margin-left:58.3333333333%}.v-application--is-rtl .flex.offset-sm7{margin-right:58.3333333333%}.v-application--is-ltr .flex.offset-sm6{margin-left:50%}.v-application--is-rtl .flex.offset-sm6{margin-right:50%}.v-application--is-ltr .flex.offset-sm5{margin-left:41.6666666667%}.v-application--is-rtl .flex.offset-sm5{margin-right:41.6666666667%}.v-application--is-ltr .flex.offset-sm4{margin-left:33.3333333333%}.v-application--is-rtl .flex.offset-sm4{margin-right:33.3333333333%}.v-application--is-ltr .flex.offset-sm3{margin-left:25%}.v-application--is-rtl .flex.offset-sm3{margin-right:25%}.v-application--is-ltr .flex.offset-sm2{margin-left:16.6666666667%}.v-application--is-rtl .flex.offset-sm2{margin-right:16.6666666667%}.v-application--is-ltr .flex.offset-sm1{margin-left:8.3333333333%}.v-application--is-rtl .flex.offset-sm1{margin-right:8.3333333333%}.v-application--is-ltr .flex.offset-sm0{margin-left:0}.v-application--is-rtl .flex.offset-sm0{margin-right:0}}@media (min-width:960px){.flex.md12{flex-basis:100%;flex-grow:0;max-width:100%}.flex.order-md12{order:12}.flex.md11{flex-basis:91.6666666667%;flex-grow:0;max-width:91.6666666667%}.flex.order-md11{order:11}.flex.md10{flex-basis:83.3333333333%;flex-grow:0;max-width:83.3333333333%}.flex.order-md10{order:10}.flex.md9{flex-basis:75%;flex-grow:0;max-width:75%}.flex.order-md9{order:9}.flex.md8{flex-basis:66.6666666667%;flex-grow:0;max-width:66.6666666667%}.flex.order-md8{order:8}.flex.md7{flex-basis:58.3333333333%;flex-grow:0;max-width:58.3333333333%}.flex.order-md7{order:7}.flex.md6{flex-basis:50%;flex-grow:0;max-width:50%}.flex.order-md6{order:6}.flex.md5{flex-basis:41.6666666667%;flex-grow:0;max-width:41.6666666667%}.flex.order-md5{order:5}.flex.md4{flex-basis:33.3333333333%;flex-grow:0;max-width:33.3333333333%}.flex.order-md4{order:4}.flex.md3{flex-basis:25%;flex-grow:0;max-width:25%}.flex.order-md3{order:3}.flex.md2{flex-basis:16.6666666667%;flex-grow:0;max-width:16.6666666667%}.flex.order-md2{order:2}.flex.md1{flex-basis:8.3333333333%;flex-grow:0;max-width:8.3333333333%}.flex.order-md1{order:1}.v-application--is-ltr .flex.offset-md12{margin-left:100%}.v-application--is-rtl .flex.offset-md12{margin-right:100%}.v-application--is-ltr .flex.offset-md11{margin-left:91.6666666667%}.v-application--is-rtl .flex.offset-md11{margin-right:91.6666666667%}.v-application--is-ltr .flex.offset-md10{margin-left:83.3333333333%}.v-application--is-rtl .flex.offset-md10{margin-right:83.3333333333%}.v-application--is-ltr .flex.offset-md9{margin-left:75%}.v-application--is-rtl .flex.offset-md9{margin-right:75%}.v-application--is-ltr .flex.offset-md8{margin-left:66.6666666667%}.v-application--is-rtl .flex.offset-md8{margin-right:66.6666666667%}.v-application--is-ltr .flex.offset-md7{margin-left:58.3333333333%}.v-application--is-rtl .flex.offset-md7{margin-right:58.3333333333%}.v-application--is-ltr .flex.offset-md6{margin-left:50%}.v-application--is-rtl .flex.offset-md6{margin-right:50%}.v-application--is-ltr .flex.offset-md5{margin-left:41.6666666667%}.v-application--is-rtl .flex.offset-md5{margin-right:41.6666666667%}.v-application--is-ltr .flex.offset-md4{margin-left:33.3333333333%}.v-application--is-rtl .flex.offset-md4{margin-right:33.3333333333%}.v-application--is-ltr .flex.offset-md3{margin-left:25%}.v-application--is-rtl .flex.offset-md3{margin-right:25%}.v-application--is-ltr .flex.offset-md2{margin-left:16.6666666667%}.v-application--is-rtl .flex.offset-md2{margin-right:16.6666666667%}.v-application--is-ltr .flex.offset-md1{margin-left:8.3333333333%}.v-application--is-rtl .flex.offset-md1{margin-right:8.3333333333%}.v-application--is-ltr .flex.offset-md0{margin-left:0}.v-application--is-rtl .flex.offset-md0{margin-right:0}}@media (min-width:1264px){.flex.lg12{flex-basis:100%;flex-grow:0;max-width:100%}.flex.order-lg12{order:12}.flex.lg11{flex-basis:91.6666666667%;flex-grow:0;max-width:91.6666666667%}.flex.order-lg11{order:11}.flex.lg10{flex-basis:83.3333333333%;flex-grow:0;max-width:83.3333333333%}.flex.order-lg10{order:10}.flex.lg9{flex-basis:75%;flex-grow:0;max-width:75%}.flex.order-lg9{order:9}.flex.lg8{flex-basis:66.6666666667%;flex-grow:0;max-width:66.6666666667%}.flex.order-lg8{order:8}.flex.lg7{flex-basis:58.3333333333%;flex-grow:0;max-width:58.3333333333%}.flex.order-lg7{order:7}.flex.lg6{flex-basis:50%;flex-grow:0;max-width:50%}.flex.order-lg6{order:6}.flex.lg5{flex-basis:41.6666666667%;flex-grow:0;max-width:41.6666666667%}.flex.order-lg5{order:5}.flex.lg4{flex-basis:33.3333333333%;flex-grow:0;max-width:33.3333333333%}.flex.order-lg4{order:4}.flex.lg3{flex-basis:25%;flex-grow:0;max-width:25%}.flex.order-lg3{order:3}.flex.lg2{flex-basis:16.6666666667%;flex-grow:0;max-width:16.6666666667%}.flex.order-lg2{order:2}.flex.lg1{flex-basis:8.3333333333%;flex-grow:0;max-width:8.3333333333%}.flex.order-lg1{order:1}.v-application--is-ltr .flex.offset-lg12{margin-left:100%}.v-application--is-rtl .flex.offset-lg12{margin-right:100%}.v-application--is-ltr .flex.offset-lg11{margin-left:91.6666666667%}.v-application--is-rtl .flex.offset-lg11{margin-right:91.6666666667%}.v-application--is-ltr .flex.offset-lg10{margin-left:83.3333333333%}.v-application--is-rtl .flex.offset-lg10{margin-right:83.3333333333%}.v-application--is-ltr .flex.offset-lg9{margin-left:75%}.v-application--is-rtl .flex.offset-lg9{margin-right:75%}.v-application--is-ltr .flex.offset-lg8{margin-left:66.6666666667%}.v-application--is-rtl .flex.offset-lg8{margin-right:66.6666666667%}.v-application--is-ltr .flex.offset-lg7{margin-left:58.3333333333%}.v-application--is-rtl .flex.offset-lg7{margin-right:58.3333333333%}.v-application--is-ltr .flex.offset-lg6{margin-left:50%}.v-application--is-rtl .flex.offset-lg6{margin-right:50%}.v-application--is-ltr .flex.offset-lg5{margin-left:41.6666666667%}.v-application--is-rtl .flex.offset-lg5{margin-right:41.6666666667%}.v-application--is-ltr .flex.offset-lg4{margin-left:33.3333333333%}.v-application--is-rtl .flex.offset-lg4{margin-right:33.3333333333%}.v-application--is-ltr .flex.offset-lg3{margin-left:25%}.v-application--is-rtl .flex.offset-lg3{margin-right:25%}.v-application--is-ltr .flex.offset-lg2{margin-left:16.6666666667%}.v-application--is-rtl .flex.offset-lg2{margin-right:16.6666666667%}.v-application--is-ltr .flex.offset-lg1{margin-left:8.3333333333%}.v-application--is-rtl .flex.offset-lg1{margin-right:8.3333333333%}.v-application--is-ltr .flex.offset-lg0{margin-left:0}.v-application--is-rtl .flex.offset-lg0{margin-right:0}}@media (min-width:1904px){.flex.xl12{flex-basis:100%;flex-grow:0;max-width:100%}.flex.order-xl12{order:12}.flex.xl11{flex-basis:91.6666666667%;flex-grow:0;max-width:91.6666666667%}.flex.order-xl11{order:11}.flex.xl10{flex-basis:83.3333333333%;flex-grow:0;max-width:83.3333333333%}.flex.order-xl10{order:10}.flex.xl9{flex-basis:75%;flex-grow:0;max-width:75%}.flex.order-xl9{order:9}.flex.xl8{flex-basis:66.6666666667%;flex-grow:0;max-width:66.6666666667%}.flex.order-xl8{order:8}.flex.xl7{flex-basis:58.3333333333%;flex-grow:0;max-width:58.3333333333%}.flex.order-xl7{order:7}.flex.xl6{flex-basis:50%;flex-grow:0;max-width:50%}.flex.order-xl6{order:6}.flex.xl5{flex-basis:41.6666666667%;flex-grow:0;max-width:41.6666666667%}.flex.order-xl5{order:5}.flex.xl4{flex-basis:33.3333333333%;flex-grow:0;max-width:33.3333333333%}.flex.order-xl4{order:4}.flex.xl3{flex-basis:25%;flex-grow:0;max-width:25%}.flex.order-xl3{order:3}.flex.xl2{flex-basis:16.6666666667%;flex-grow:0;max-width:16.6666666667%}.flex.order-xl2{order:2}.flex.xl1{flex-basis:8.3333333333%;flex-grow:0;max-width:8.3333333333%}.flex.order-xl1{order:1}.v-application--is-ltr .flex.offset-xl12{margin-left:100%}.v-application--is-rtl .flex.offset-xl12{margin-right:100%}.v-application--is-ltr .flex.offset-xl11{margin-left:91.6666666667%}.v-application--is-rtl .flex.offset-xl11{margin-right:91.6666666667%}.v-application--is-ltr .flex.offset-xl10{margin-left:83.3333333333%}.v-application--is-rtl .flex.offset-xl10{margin-right:83.3333333333%}.v-application--is-ltr .flex.offset-xl9{margin-left:75%}.v-application--is-rtl .flex.offset-xl9{margin-right:75%}.v-application--is-ltr .flex.offset-xl8{margin-left:66.6666666667%}.v-application--is-rtl .flex.offset-xl8{margin-right:66.6666666667%}.v-application--is-ltr .flex.offset-xl7{margin-left:58.3333333333%}.v-application--is-rtl .flex.offset-xl7{margin-right:58.3333333333%}.v-application--is-ltr .flex.offset-xl6{margin-left:50%}.v-application--is-rtl .flex.offset-xl6{margin-right:50%}.v-application--is-ltr .flex.offset-xl5{margin-left:41.6666666667%}.v-application--is-rtl .flex.offset-xl5{margin-right:41.6666666667%}.v-application--is-ltr .flex.offset-xl4{margin-left:33.3333333333%}.v-application--is-rtl .flex.offset-xl4{margin-right:33.3333333333%}.v-application--is-ltr .flex.offset-xl3{margin-left:25%}.v-application--is-rtl .flex.offset-xl3{margin-right:25%}.v-application--is-ltr .flex.offset-xl2{margin-left:16.6666666667%}.v-application--is-rtl .flex.offset-xl2{margin-right:16.6666666667%}.v-application--is-ltr .flex.offset-xl1{margin-left:8.3333333333%}.v-application--is-rtl .flex.offset-xl1{margin-right:8.3333333333%}.v-application--is-ltr .flex.offset-xl0{margin-left:0}.v-application--is-rtl .flex.offset-xl0{margin-right:0}}.child-flex>*,.flex{flex:1 1 auto;max-width:100%}.child-flex>.grow-shrink-0,.flex.grow-shrink-0{flex-grow:0;flex-shrink:0}.grow,.spacer{flex-grow:1!important}.grow{flex-shrink:0!important}.shrink{flex-grow:0!important;flex-shrink:1!important}.fill-height{height:100%}.theme--light.v-image{color:rgba(0,0,0,.87)}.theme--dark.v-image{color:#fff}.v-image{z-index:0}.v-image__image,.v-image__placeholder{z-index:-1;position:absolute;top:0;left:0;width:100%;height:100%}.v-image__image{background-repeat:no-repeat}.v-image__image--preload{filter:blur(2px)}.v-image__image--contain{background-size:contain}.v-image__image--cover{background-size:cover}.v-responsive{position:relative;overflow:hidden;flex:1 0 auto;max-width:100%;display:flex}.v-responsive__content{flex:1 0 0px;max-width:100%}.v-application--is-ltr .v-responsive__sizer~.v-responsive__content{margin-left:-100%}.v-application--is-rtl .v-responsive__sizer~.v-responsive__content{margin-right:-100%}.v-responsive__sizer{transition:padding-bottom .2s cubic-bezier(.25,.8,.5,1);flex:1 0 0px}@keyframes v-shake{59%{margin-left:0}60%,80%{margin-left:2px}70%,90%{margin-left:-2px}}.v-application .black{background-color:#000!important;border-color:#000!important}.v-application .black--text{color:#000!important;caret-color:#000!important}.v-application .white{background-color:#fff!important;border-color:#fff!important}.v-application .white--text{color:#fff!important;caret-color:#fff!important}.v-application .transparent{background-color:transparent!important;border-color:transparent!important}.v-application .transparent--text{color:transparent!important;caret-color:transparent!important}.v-application .red{background-color:#f44336!important;border-color:#f44336!important}.v-application .red--text{color:#f44336!important;caret-color:#f44336!important}.v-application .red.lighten-5{background-color:#ffebee!important;border-color:#ffebee!important}.v-application .red--text.text--lighten-5{color:#ffebee!important;caret-color:#ffebee!important}.v-application .red.lighten-4{background-color:#ffcdd2!important;border-color:#ffcdd2!important}.v-application .red--text.text--lighten-4{color:#ffcdd2!important;caret-color:#ffcdd2!important}.v-application .red.lighten-3{background-color:#ef9a9a!important;border-color:#ef9a9a!important}.v-application .red--text.text--lighten-3{color:#ef9a9a!important;caret-color:#ef9a9a!important}.v-application .red.lighten-2{background-color:#e57373!important;border-color:#e57373!important}.v-application .red--text.text--lighten-2{color:#e57373!important;caret-color:#e57373!important}.v-application .red.lighten-1{background-color:#ef5350!important;border-color:#ef5350!important}.v-application .red--text.text--lighten-1{color:#ef5350!important;caret-color:#ef5350!important}.v-application .red.darken-1{background-color:#e53935!important;border-color:#e53935!important}.v-application .red--text.text--darken-1{color:#e53935!important;caret-color:#e53935!important}.v-application .red.darken-2{background-color:#d32f2f!important;border-color:#d32f2f!important}.v-application .red--text.text--darken-2{color:#d32f2f!important;caret-color:#d32f2f!important}.v-application .red.darken-3{background-color:#c62828!important;border-color:#c62828!important}.v-application .red--text.text--darken-3{color:#c62828!important;caret-color:#c62828!important}.v-application .red.darken-4{background-color:#b71c1c!important;border-color:#b71c1c!important}.v-application .red--text.text--darken-4{color:#b71c1c!important;caret-color:#b71c1c!important}.v-application .red.accent-1{background-color:#ff8a80!important;border-color:#ff8a80!important}.v-application .red--text.text--accent-1{color:#ff8a80!important;caret-color:#ff8a80!important}.v-application .red.accent-2{background-color:#ff5252!important;border-color:#ff5252!important}.v-application .red--text.text--accent-2{color:#ff5252!important;caret-color:#ff5252!important}.v-application .red.accent-3{background-color:#ff1744!important;border-color:#ff1744!important}.v-application .red--text.text--accent-3{color:#ff1744!important;caret-color:#ff1744!important}.v-application .red.accent-4{background-color:#d50000!important;border-color:#d50000!important}.v-application .red--text.text--accent-4{color:#d50000!important;caret-color:#d50000!important}.v-application .pink{background-color:#e91e63!important;border-color:#e91e63!important}.v-application .pink--text{color:#e91e63!important;caret-color:#e91e63!important}.v-application .pink.lighten-5{background-color:#fce4ec!important;border-color:#fce4ec!important}.v-application .pink--text.text--lighten-5{color:#fce4ec!important;caret-color:#fce4ec!important}.v-application .pink.lighten-4{background-color:#f8bbd0!important;border-color:#f8bbd0!important}.v-application .pink--text.text--lighten-4{color:#f8bbd0!important;caret-color:#f8bbd0!important}.v-application .pink.lighten-3{background-color:#f48fb1!important;border-color:#f48fb1!important}.v-application .pink--text.text--lighten-3{color:#f48fb1!important;caret-color:#f48fb1!important}.v-application .pink.lighten-2{background-color:#f06292!important;border-color:#f06292!important}.v-application .pink--text.text--lighten-2{color:#f06292!important;caret-color:#f06292!important}.v-application .pink.lighten-1{background-color:#ec407a!important;border-color:#ec407a!important}.v-application .pink--text.text--lighten-1{color:#ec407a!important;caret-color:#ec407a!important}.v-application .pink.darken-1{background-color:#d81b60!important;border-color:#d81b60!important}.v-application .pink--text.text--darken-1{color:#d81b60!important;caret-color:#d81b60!important}.v-application .pink.darken-2{background-color:#c2185b!important;border-color:#c2185b!important}.v-application .pink--text.text--darken-2{color:#c2185b!important;caret-color:#c2185b!important}.v-application .pink.darken-3{background-color:#ad1457!important;border-color:#ad1457!important}.v-application .pink--text.text--darken-3{color:#ad1457!important;caret-color:#ad1457!important}.v-application .pink.darken-4{background-color:#880e4f!important;border-color:#880e4f!important}.v-application .pink--text.text--darken-4{color:#880e4f!important;caret-color:#880e4f!important}.v-application .pink.accent-1{background-color:#ff80ab!important;border-color:#ff80ab!important}.v-application .pink--text.text--accent-1{color:#ff80ab!important;caret-color:#ff80ab!important}.v-application .pink.accent-2{background-color:#ff4081!important;border-color:#ff4081!important}.v-application .pink--text.text--accent-2{color:#ff4081!important;caret-color:#ff4081!important}.v-application .pink.accent-3{background-color:#f50057!important;border-color:#f50057!important}.v-application .pink--text.text--accent-3{color:#f50057!important;caret-color:#f50057!important}.v-application .pink.accent-4{background-color:#c51162!important;border-color:#c51162!important}.v-application .pink--text.text--accent-4{color:#c51162!important;caret-color:#c51162!important}.v-application .purple{background-color:#9c27b0!important;border-color:#9c27b0!important}.v-application .purple--text{color:#9c27b0!important;caret-color:#9c27b0!important}.v-application .purple.lighten-5{background-color:#f3e5f5!important;border-color:#f3e5f5!important}.v-application .purple--text.text--lighten-5{color:#f3e5f5!important;caret-color:#f3e5f5!important}.v-application .purple.lighten-4{background-color:#e1bee7!important;border-color:#e1bee7!important}.v-application .purple--text.text--lighten-4{color:#e1bee7!important;caret-color:#e1bee7!important}.v-application .purple.lighten-3{background-color:#ce93d8!important;border-color:#ce93d8!important}.v-application .purple--text.text--lighten-3{color:#ce93d8!important;caret-color:#ce93d8!important}.v-application .purple.lighten-2{background-color:#ba68c8!important;border-color:#ba68c8!important}.v-application .purple--text.text--lighten-2{color:#ba68c8!important;caret-color:#ba68c8!important}.v-application .purple.lighten-1{background-color:#ab47bc!important;border-color:#ab47bc!important}.v-application .purple--text.text--lighten-1{color:#ab47bc!important;caret-color:#ab47bc!important}.v-application .purple.darken-1{background-color:#8e24aa!important;border-color:#8e24aa!important}.v-application .purple--text.text--darken-1{color:#8e24aa!important;caret-color:#8e24aa!important}.v-application .purple.darken-2{background-color:#7b1fa2!important;border-color:#7b1fa2!important}.v-application .purple--text.text--darken-2{color:#7b1fa2!important;caret-color:#7b1fa2!important}.v-application .purple.darken-3{background-color:#6a1b9a!important;border-color:#6a1b9a!important}.v-application .purple--text.text--darken-3{color:#6a1b9a!important;caret-color:#6a1b9a!important}.v-application .purple.darken-4{background-color:#4a148c!important;border-color:#4a148c!important}.v-application .purple--text.text--darken-4{color:#4a148c!important;caret-color:#4a148c!important}.v-application .purple.accent-1{background-color:#ea80fc!important;border-color:#ea80fc!important}.v-application .purple--text.text--accent-1{color:#ea80fc!important;caret-color:#ea80fc!important}.v-application .purple.accent-2{background-color:#e040fb!important;border-color:#e040fb!important}.v-application .purple--text.text--accent-2{color:#e040fb!important;caret-color:#e040fb!important}.v-application .purple.accent-3{background-color:#d500f9!important;border-color:#d500f9!important}.v-application .purple--text.text--accent-3{color:#d500f9!important;caret-color:#d500f9!important}.v-application .purple.accent-4{background-color:#a0f!important;border-color:#a0f!important}.v-application .purple--text.text--accent-4{color:#a0f!important;caret-color:#a0f!important}.v-application .deep-purple{background-color:#673ab7!important;border-color:#673ab7!important}.v-application .deep-purple--text{color:#673ab7!important;caret-color:#673ab7!important}.v-application .deep-purple.lighten-5{background-color:#ede7f6!important;border-color:#ede7f6!important}.v-application .deep-purple--text.text--lighten-5{color:#ede7f6!important;caret-color:#ede7f6!important}.v-application .deep-purple.lighten-4{background-color:#d1c4e9!important;border-color:#d1c4e9!important}.v-application .deep-purple--text.text--lighten-4{color:#d1c4e9!important;caret-color:#d1c4e9!important}.v-application .deep-purple.lighten-3{background-color:#b39ddb!important;border-color:#b39ddb!important}.v-application .deep-purple--text.text--lighten-3{color:#b39ddb!important;caret-color:#b39ddb!important}.v-application .deep-purple.lighten-2{background-color:#9575cd!important;border-color:#9575cd!important}.v-application .deep-purple--text.text--lighten-2{color:#9575cd!important;caret-color:#9575cd!important}.v-application .deep-purple.lighten-1{background-color:#7e57c2!important;border-color:#7e57c2!important}.v-application .deep-purple--text.text--lighten-1{color:#7e57c2!important;caret-color:#7e57c2!important}.v-application .deep-purple.darken-1{background-color:#5e35b1!important;border-color:#5e35b1!important}.v-application .deep-purple--text.text--darken-1{color:#5e35b1!important;caret-color:#5e35b1!important}.v-application .deep-purple.darken-2{background-color:#512da8!important;border-color:#512da8!important}.v-application .deep-purple--text.text--darken-2{color:#512da8!important;caret-color:#512da8!important}.v-application .deep-purple.darken-3{background-color:#4527a0!important;border-color:#4527a0!important}.v-application .deep-purple--text.text--darken-3{color:#4527a0!important;caret-color:#4527a0!important}.v-application .deep-purple.darken-4{background-color:#311b92!important;border-color:#311b92!important}.v-application .deep-purple--text.text--darken-4{color:#311b92!important;caret-color:#311b92!important}.v-application .deep-purple.accent-1{background-color:#b388ff!important;border-color:#b388ff!important}.v-application .deep-purple--text.text--accent-1{color:#b388ff!important;caret-color:#b388ff!important}.v-application .deep-purple.accent-2{background-color:#7c4dff!important;border-color:#7c4dff!important}.v-application .deep-purple--text.text--accent-2{color:#7c4dff!important;caret-color:#7c4dff!important}.v-application .deep-purple.accent-3{background-color:#651fff!important;border-color:#651fff!important}.v-application .deep-purple--text.text--accent-3{color:#651fff!important;caret-color:#651fff!important}.v-application .deep-purple.accent-4{background-color:#6200ea!important;border-color:#6200ea!important}.v-application .deep-purple--text.text--accent-4{color:#6200ea!important;caret-color:#6200ea!important}.v-application .indigo{background-color:#3f51b5!important;border-color:#3f51b5!important}.v-application .indigo--text{color:#3f51b5!important;caret-color:#3f51b5!important}.v-application .indigo.lighten-5{background-color:#e8eaf6!important;border-color:#e8eaf6!important}.v-application .indigo--text.text--lighten-5{color:#e8eaf6!important;caret-color:#e8eaf6!important}.v-application .indigo.lighten-4{background-color:#c5cae9!important;border-color:#c5cae9!important}.v-application .indigo--text.text--lighten-4{color:#c5cae9!important;caret-color:#c5cae9!important}.v-application .indigo.lighten-3{background-color:#9fa8da!important;border-color:#9fa8da!important}.v-application .indigo--text.text--lighten-3{color:#9fa8da!important;caret-color:#9fa8da!important}.v-application .indigo.lighten-2{background-color:#7986cb!important;border-color:#7986cb!important}.v-application .indigo--text.text--lighten-2{color:#7986cb!important;caret-color:#7986cb!important}.v-application .indigo.lighten-1{background-color:#5c6bc0!important;border-color:#5c6bc0!important}.v-application .indigo--text.text--lighten-1{color:#5c6bc0!important;caret-color:#5c6bc0!important}.v-application .indigo.darken-1{background-color:#3949ab!important;border-color:#3949ab!important}.v-application .indigo--text.text--darken-1{color:#3949ab!important;caret-color:#3949ab!important}.v-application .indigo.darken-2{background-color:#303f9f!important;border-color:#303f9f!important}.v-application .indigo--text.text--darken-2{color:#303f9f!important;caret-color:#303f9f!important}.v-application .indigo.darken-3{background-color:#283593!important;border-color:#283593!important}.v-application .indigo--text.text--darken-3{color:#283593!important;caret-color:#283593!important}.v-application .indigo.darken-4{background-color:#1a237e!important;border-color:#1a237e!important}.v-application .indigo--text.text--darken-4{color:#1a237e!important;caret-color:#1a237e!important}.v-application .indigo.accent-1{background-color:#8c9eff!important;border-color:#8c9eff!important}.v-application .indigo--text.text--accent-1{color:#8c9eff!important;caret-color:#8c9eff!important}.v-application .indigo.accent-2{background-color:#536dfe!important;border-color:#536dfe!important}.v-application .indigo--text.text--accent-2{color:#536dfe!important;caret-color:#536dfe!important}.v-application .indigo.accent-3{background-color:#3d5afe!important;border-color:#3d5afe!important}.v-application .indigo--text.text--accent-3{color:#3d5afe!important;caret-color:#3d5afe!important}.v-application .indigo.accent-4{background-color:#304ffe!important;border-color:#304ffe!important}.v-application .indigo--text.text--accent-4{color:#304ffe!important;caret-color:#304ffe!important}.v-application .blue{background-color:#2196f3!important;border-color:#2196f3!important}.v-application .blue--text{color:#2196f3!important;caret-color:#2196f3!important}.v-application .blue.lighten-5{background-color:#e3f2fd!important;border-color:#e3f2fd!important}.v-application .blue--text.text--lighten-5{color:#e3f2fd!important;caret-color:#e3f2fd!important}.v-application .blue.lighten-4{background-color:#bbdefb!important;border-color:#bbdefb!important}.v-application .blue--text.text--lighten-4{color:#bbdefb!important;caret-color:#bbdefb!important}.v-application .blue.lighten-3{background-color:#90caf9!important;border-color:#90caf9!important}.v-application .blue--text.text--lighten-3{color:#90caf9!important;caret-color:#90caf9!important}.v-application .blue.lighten-2{background-color:#64b5f6!important;border-color:#64b5f6!important}.v-application .blue--text.text--lighten-2{color:#64b5f6!important;caret-color:#64b5f6!important}.v-application .blue.lighten-1{background-color:#42a5f5!important;border-color:#42a5f5!important}.v-application .blue--text.text--lighten-1{color:#42a5f5!important;caret-color:#42a5f5!important}.v-application .blue.darken-1{background-color:#1e88e5!important;border-color:#1e88e5!important}.v-application .blue--text.text--darken-1{color:#1e88e5!important;caret-color:#1e88e5!important}.v-application .blue.darken-2{background-color:#1976d2!important;border-color:#1976d2!important}.v-application .blue--text.text--darken-2{color:#1976d2!important;caret-color:#1976d2!important}.v-application .blue.darken-3{background-color:#1565c0!important;border-color:#1565c0!important}.v-application .blue--text.text--darken-3{color:#1565c0!important;caret-color:#1565c0!important}.v-application .blue.darken-4{background-color:#0d47a1!important;border-color:#0d47a1!important}.v-application .blue--text.text--darken-4{color:#0d47a1!important;caret-color:#0d47a1!important}.v-application .blue.accent-1{background-color:#82b1ff!important;border-color:#82b1ff!important}.v-application .blue--text.text--accent-1{color:#82b1ff!important;caret-color:#82b1ff!important}.v-application .blue.accent-2{background-color:#448aff!important;border-color:#448aff!important}.v-application .blue--text.text--accent-2{color:#448aff!important;caret-color:#448aff!important}.v-application .blue.accent-3{background-color:#2979ff!important;border-color:#2979ff!important}.v-application .blue--text.text--accent-3{color:#2979ff!important;caret-color:#2979ff!important}.v-application .blue.accent-4{background-color:#2962ff!important;border-color:#2962ff!important}.v-application .blue--text.text--accent-4{color:#2962ff!important;caret-color:#2962ff!important}.v-application .light-blue{background-color:#03a9f4!important;border-color:#03a9f4!important}.v-application .light-blue--text{color:#03a9f4!important;caret-color:#03a9f4!important}.v-application .light-blue.lighten-5{background-color:#e1f5fe!important;border-color:#e1f5fe!important}.v-application .light-blue--text.text--lighten-5{color:#e1f5fe!important;caret-color:#e1f5fe!important}.v-application .light-blue.lighten-4{background-color:#b3e5fc!important;border-color:#b3e5fc!important}.v-application .light-blue--text.text--lighten-4{color:#b3e5fc!important;caret-color:#b3e5fc!important}.v-application .light-blue.lighten-3{background-color:#81d4fa!important;border-color:#81d4fa!important}.v-application .light-blue--text.text--lighten-3{color:#81d4fa!important;caret-color:#81d4fa!important}.v-application .light-blue.lighten-2{background-color:#4fc3f7!important;border-color:#4fc3f7!important}.v-application .light-blue--text.text--lighten-2{color:#4fc3f7!important;caret-color:#4fc3f7!important}.v-application .light-blue.lighten-1{background-color:#29b6f6!important;border-color:#29b6f6!important}.v-application .light-blue--text.text--lighten-1{color:#29b6f6!important;caret-color:#29b6f6!important}.v-application .light-blue.darken-1{background-color:#039be5!important;border-color:#039be5!important}.v-application .light-blue--text.text--darken-1{color:#039be5!important;caret-color:#039be5!important}.v-application .light-blue.darken-2{background-color:#0288d1!important;border-color:#0288d1!important}.v-application .light-blue--text.text--darken-2{color:#0288d1!important;caret-color:#0288d1!important}.v-application .light-blue.darken-3{background-color:#0277bd!important;border-color:#0277bd!important}.v-application .light-blue--text.text--darken-3{color:#0277bd!important;caret-color:#0277bd!important}.v-application .light-blue.darken-4{background-color:#01579b!important;border-color:#01579b!important}.v-application .light-blue--text.text--darken-4{color:#01579b!important;caret-color:#01579b!important}.v-application .light-blue.accent-1{background-color:#80d8ff!important;border-color:#80d8ff!important}.v-application .light-blue--text.text--accent-1{color:#80d8ff!important;caret-color:#80d8ff!important}.v-application .light-blue.accent-2{background-color:#40c4ff!important;border-color:#40c4ff!important}.v-application .light-blue--text.text--accent-2{color:#40c4ff!important;caret-color:#40c4ff!important}.v-application .light-blue.accent-3{background-color:#00b0ff!important;border-color:#00b0ff!important}.v-application .light-blue--text.text--accent-3{color:#00b0ff!important;caret-color:#00b0ff!important}.v-application .light-blue.accent-4{background-color:#0091ea!important;border-color:#0091ea!important}.v-application .light-blue--text.text--accent-4{color:#0091ea!important;caret-color:#0091ea!important}.v-application .cyan{background-color:#00bcd4!important;border-color:#00bcd4!important}.v-application .cyan--text{color:#00bcd4!important;caret-color:#00bcd4!important}.v-application .cyan.lighten-5{background-color:#e0f7fa!important;border-color:#e0f7fa!important}.v-application .cyan--text.text--lighten-5{color:#e0f7fa!important;caret-color:#e0f7fa!important}.v-application .cyan.lighten-4{background-color:#b2ebf2!important;border-color:#b2ebf2!important}.v-application .cyan--text.text--lighten-4{color:#b2ebf2!important;caret-color:#b2ebf2!important}.v-application .cyan.lighten-3{background-color:#80deea!important;border-color:#80deea!important}.v-application .cyan--text.text--lighten-3{color:#80deea!important;caret-color:#80deea!important}.v-application .cyan.lighten-2{background-color:#4dd0e1!important;border-color:#4dd0e1!important}.v-application .cyan--text.text--lighten-2{color:#4dd0e1!important;caret-color:#4dd0e1!important}.v-application .cyan.lighten-1{background-color:#26c6da!important;border-color:#26c6da!important}.v-application .cyan--text.text--lighten-1{color:#26c6da!important;caret-color:#26c6da!important}.v-application .cyan.darken-1{background-color:#00acc1!important;border-color:#00acc1!important}.v-application .cyan--text.text--darken-1{color:#00acc1!important;caret-color:#00acc1!important}.v-application .cyan.darken-2{background-color:#0097a7!important;border-color:#0097a7!important}.v-application .cyan--text.text--darken-2{color:#0097a7!important;caret-color:#0097a7!important}.v-application .cyan.darken-3{background-color:#00838f!important;border-color:#00838f!important}.v-application .cyan--text.text--darken-3{color:#00838f!important;caret-color:#00838f!important}.v-application .cyan.darken-4{background-color:#006064!important;border-color:#006064!important}.v-application .cyan--text.text--darken-4{color:#006064!important;caret-color:#006064!important}.v-application .cyan.accent-1{background-color:#84ffff!important;border-color:#84ffff!important}.v-application .cyan--text.text--accent-1{color:#84ffff!important;caret-color:#84ffff!important}.v-application .cyan.accent-2{background-color:#18ffff!important;border-color:#18ffff!important}.v-application .cyan--text.text--accent-2{color:#18ffff!important;caret-color:#18ffff!important}.v-application .cyan.accent-3{background-color:#00e5ff!important;border-color:#00e5ff!important}.v-application .cyan--text.text--accent-3{color:#00e5ff!important;caret-color:#00e5ff!important}.v-application .cyan.accent-4{background-color:#00b8d4!important;border-color:#00b8d4!important}.v-application .cyan--text.text--accent-4{color:#00b8d4!important;caret-color:#00b8d4!important}.v-application .teal{background-color:#009688!important;border-color:#009688!important}.v-application .teal--text{color:#009688!important;caret-color:#009688!important}.v-application .teal.lighten-5{background-color:#e0f2f1!important;border-color:#e0f2f1!important}.v-application .teal--text.text--lighten-5{color:#e0f2f1!important;caret-color:#e0f2f1!important}.v-application .teal.lighten-4{background-color:#b2dfdb!important;border-color:#b2dfdb!important}.v-application .teal--text.text--lighten-4{color:#b2dfdb!important;caret-color:#b2dfdb!important}.v-application .teal.lighten-3{background-color:#80cbc4!important;border-color:#80cbc4!important}.v-application .teal--text.text--lighten-3{color:#80cbc4!important;caret-color:#80cbc4!important}.v-application .teal.lighten-2{background-color:#4db6ac!important;border-color:#4db6ac!important}.v-application .teal--text.text--lighten-2{color:#4db6ac!important;caret-color:#4db6ac!important}.v-application .teal.lighten-1{background-color:#26a69a!important;border-color:#26a69a!important}.v-application .teal--text.text--lighten-1{color:#26a69a!important;caret-color:#26a69a!important}.v-application .teal.darken-1{background-color:#00897b!important;border-color:#00897b!important}.v-application .teal--text.text--darken-1{color:#00897b!important;caret-color:#00897b!important}.v-application .teal.darken-2{background-color:#00796b!important;border-color:#00796b!important}.v-application .teal--text.text--darken-2{color:#00796b!important;caret-color:#00796b!important}.v-application .teal.darken-3{background-color:#00695c!important;border-color:#00695c!important}.v-application .teal--text.text--darken-3{color:#00695c!important;caret-color:#00695c!important}.v-application .teal.darken-4{background-color:#004d40!important;border-color:#004d40!important}.v-application .teal--text.text--darken-4{color:#004d40!important;caret-color:#004d40!important}.v-application .teal.accent-1{background-color:#a7ffeb!important;border-color:#a7ffeb!important}.v-application .teal--text.text--accent-1{color:#a7ffeb!important;caret-color:#a7ffeb!important}.v-application .teal.accent-2{background-color:#64ffda!important;border-color:#64ffda!important}.v-application .teal--text.text--accent-2{color:#64ffda!important;caret-color:#64ffda!important}.v-application .teal.accent-3{background-color:#1de9b6!important;border-color:#1de9b6!important}.v-application .teal--text.text--accent-3{color:#1de9b6!important;caret-color:#1de9b6!important}.v-application .teal.accent-4{background-color:#00bfa5!important;border-color:#00bfa5!important}.v-application .teal--text.text--accent-4{color:#00bfa5!important;caret-color:#00bfa5!important}.v-application .green{background-color:#4caf50!important;border-color:#4caf50!important}.v-application .green--text{color:#4caf50!important;caret-color:#4caf50!important}.v-application .green.lighten-5{background-color:#e8f5e9!important;border-color:#e8f5e9!important}.v-application .green--text.text--lighten-5{color:#e8f5e9!important;caret-color:#e8f5e9!important}.v-application .green.lighten-4{background-color:#c8e6c9!important;border-color:#c8e6c9!important}.v-application .green--text.text--lighten-4{color:#c8e6c9!important;caret-color:#c8e6c9!important}.v-application .green.lighten-3{background-color:#a5d6a7!important;border-color:#a5d6a7!important}.v-application .green--text.text--lighten-3{color:#a5d6a7!important;caret-color:#a5d6a7!important}.v-application .green.lighten-2{background-color:#81c784!important;border-color:#81c784!important}.v-application .green--text.text--lighten-2{color:#81c784!important;caret-color:#81c784!important}.v-application .green.lighten-1{background-color:#66bb6a!important;border-color:#66bb6a!important}.v-application .green--text.text--lighten-1{color:#66bb6a!important;caret-color:#66bb6a!important}.v-application .green.darken-1{background-color:#43a047!important;border-color:#43a047!important}.v-application .green--text.text--darken-1{color:#43a047!important;caret-color:#43a047!important}.v-application .green.darken-2{background-color:#388e3c!important;border-color:#388e3c!important}.v-application .green--text.text--darken-2{color:#388e3c!important;caret-color:#388e3c!important}.v-application .green.darken-3{background-color:#2e7d32!important;border-color:#2e7d32!important}.v-application .green--text.text--darken-3{color:#2e7d32!important;caret-color:#2e7d32!important}.v-application .green.darken-4{background-color:#1b5e20!important;border-color:#1b5e20!important}.v-application .green--text.text--darken-4{color:#1b5e20!important;caret-color:#1b5e20!important}.v-application .green.accent-1{background-color:#b9f6ca!important;border-color:#b9f6ca!important}.v-application .green--text.text--accent-1{color:#b9f6ca!important;caret-color:#b9f6ca!important}.v-application .green.accent-2{background-color:#69f0ae!important;border-color:#69f0ae!important}.v-application .green--text.text--accent-2{color:#69f0ae!important;caret-color:#69f0ae!important}.v-application .green.accent-3{background-color:#00e676!important;border-color:#00e676!important}.v-application .green--text.text--accent-3{color:#00e676!important;caret-color:#00e676!important}.v-application .green.accent-4{background-color:#00c853!important;border-color:#00c853!important}.v-application .green--text.text--accent-4{color:#00c853!important;caret-color:#00c853!important}.v-application .light-green{background-color:#8bc34a!important;border-color:#8bc34a!important}.v-application .light-green--text{color:#8bc34a!important;caret-color:#8bc34a!important}.v-application .light-green.lighten-5{background-color:#f1f8e9!important;border-color:#f1f8e9!important}.v-application .light-green--text.text--lighten-5{color:#f1f8e9!important;caret-color:#f1f8e9!important}.v-application .light-green.lighten-4{background-color:#dcedc8!important;border-color:#dcedc8!important}.v-application .light-green--text.text--lighten-4{color:#dcedc8!important;caret-color:#dcedc8!important}.v-application .light-green.lighten-3{background-color:#c5e1a5!important;border-color:#c5e1a5!important}.v-application .light-green--text.text--lighten-3{color:#c5e1a5!important;caret-color:#c5e1a5!important}.v-application .light-green.lighten-2{background-color:#aed581!important;border-color:#aed581!important}.v-application .light-green--text.text--lighten-2{color:#aed581!important;caret-color:#aed581!important}.v-application .light-green.lighten-1{background-color:#9ccc65!important;border-color:#9ccc65!important}.v-application .light-green--text.text--lighten-1{color:#9ccc65!important;caret-color:#9ccc65!important}.v-application .light-green.darken-1{background-color:#7cb342!important;border-color:#7cb342!important}.v-application .light-green--text.text--darken-1{color:#7cb342!important;caret-color:#7cb342!important}.v-application .light-green.darken-2{background-color:#689f38!important;border-color:#689f38!important}.v-application .light-green--text.text--darken-2{color:#689f38!important;caret-color:#689f38!important}.v-application .light-green.darken-3{background-color:#558b2f!important;border-color:#558b2f!important}.v-application .light-green--text.text--darken-3{color:#558b2f!important;caret-color:#558b2f!important}.v-application .light-green.darken-4{background-color:#33691e!important;border-color:#33691e!important}.v-application .light-green--text.text--darken-4{color:#33691e!important;caret-color:#33691e!important}.v-application .light-green.accent-1{background-color:#ccff90!important;border-color:#ccff90!important}.v-application .light-green--text.text--accent-1{color:#ccff90!important;caret-color:#ccff90!important}.v-application .light-green.accent-2{background-color:#b2ff59!important;border-color:#b2ff59!important}.v-application .light-green--text.text--accent-2{color:#b2ff59!important;caret-color:#b2ff59!important}.v-application .light-green.accent-3{background-color:#76ff03!important;border-color:#76ff03!important}.v-application .light-green--text.text--accent-3{color:#76ff03!important;caret-color:#76ff03!important}.v-application .light-green.accent-4{background-color:#64dd17!important;border-color:#64dd17!important}.v-application .light-green--text.text--accent-4{color:#64dd17!important;caret-color:#64dd17!important}.v-application .lime{background-color:#cddc39!important;border-color:#cddc39!important}.v-application .lime--text{color:#cddc39!important;caret-color:#cddc39!important}.v-application .lime.lighten-5{background-color:#f9fbe7!important;border-color:#f9fbe7!important}.v-application .lime--text.text--lighten-5{color:#f9fbe7!important;caret-color:#f9fbe7!important}.v-application .lime.lighten-4{background-color:#f0f4c3!important;border-color:#f0f4c3!important}.v-application .lime--text.text--lighten-4{color:#f0f4c3!important;caret-color:#f0f4c3!important}.v-application .lime.lighten-3{background-color:#e6ee9c!important;border-color:#e6ee9c!important}.v-application .lime--text.text--lighten-3{color:#e6ee9c!important;caret-color:#e6ee9c!important}.v-application .lime.lighten-2{background-color:#dce775!important;border-color:#dce775!important}.v-application .lime--text.text--lighten-2{color:#dce775!important;caret-color:#dce775!important}.v-application .lime.lighten-1{background-color:#d4e157!important;border-color:#d4e157!important}.v-application .lime--text.text--lighten-1{color:#d4e157!important;caret-color:#d4e157!important}.v-application .lime.darken-1{background-color:#c0ca33!important;border-color:#c0ca33!important}.v-application .lime--text.text--darken-1{color:#c0ca33!important;caret-color:#c0ca33!important}.v-application .lime.darken-2{background-color:#afb42b!important;border-color:#afb42b!important}.v-application .lime--text.text--darken-2{color:#afb42b!important;caret-color:#afb42b!important}.v-application .lime.darken-3{background-color:#9e9d24!important;border-color:#9e9d24!important}.v-application .lime--text.text--darken-3{color:#9e9d24!important;caret-color:#9e9d24!important}.v-application .lime.darken-4{background-color:#827717!important;border-color:#827717!important}.v-application .lime--text.text--darken-4{color:#827717!important;caret-color:#827717!important}.v-application .lime.accent-1{background-color:#f4ff81!important;border-color:#f4ff81!important}.v-application .lime--text.text--accent-1{color:#f4ff81!important;caret-color:#f4ff81!important}.v-application .lime.accent-2{background-color:#eeff41!important;border-color:#eeff41!important}.v-application .lime--text.text--accent-2{color:#eeff41!important;caret-color:#eeff41!important}.v-application .lime.accent-3{background-color:#c6ff00!important;border-color:#c6ff00!important}.v-application .lime--text.text--accent-3{color:#c6ff00!important;caret-color:#c6ff00!important}.v-application .lime.accent-4{background-color:#aeea00!important;border-color:#aeea00!important}.v-application .lime--text.text--accent-4{color:#aeea00!important;caret-color:#aeea00!important}.v-application .yellow{background-color:#ffeb3b!important;border-color:#ffeb3b!important}.v-application .yellow--text{color:#ffeb3b!important;caret-color:#ffeb3b!important}.v-application .yellow.lighten-5{background-color:#fffde7!important;border-color:#fffde7!important}.v-application .yellow--text.text--lighten-5{color:#fffde7!important;caret-color:#fffde7!important}.v-application .yellow.lighten-4{background-color:#fff9c4!important;border-color:#fff9c4!important}.v-application .yellow--text.text--lighten-4{color:#fff9c4!important;caret-color:#fff9c4!important}.v-application .yellow.lighten-3{background-color:#fff59d!important;border-color:#fff59d!important}.v-application .yellow--text.text--lighten-3{color:#fff59d!important;caret-color:#fff59d!important}.v-application .yellow.lighten-2{background-color:#fff176!important;border-color:#fff176!important}.v-application .yellow--text.text--lighten-2{color:#fff176!important;caret-color:#fff176!important}.v-application .yellow.lighten-1{background-color:#ffee58!important;border-color:#ffee58!important}.v-application .yellow--text.text--lighten-1{color:#ffee58!important;caret-color:#ffee58!important}.v-application .yellow.darken-1{background-color:#fdd835!important;border-color:#fdd835!important}.v-application .yellow--text.text--darken-1{color:#fdd835!important;caret-color:#fdd835!important}.v-application .yellow.darken-2{background-color:#fbc02d!important;border-color:#fbc02d!important}.v-application .yellow--text.text--darken-2{color:#fbc02d!important;caret-color:#fbc02d!important}.v-application .yellow.darken-3{background-color:#f9a825!important;border-color:#f9a825!important}.v-application .yellow--text.text--darken-3{color:#f9a825!important;caret-color:#f9a825!important}.v-application .yellow.darken-4{background-color:#f57f17!important;border-color:#f57f17!important}.v-application .yellow--text.text--darken-4{color:#f57f17!important;caret-color:#f57f17!important}.v-application .yellow.accent-1{background-color:#ffff8d!important;border-color:#ffff8d!important}.v-application .yellow--text.text--accent-1{color:#ffff8d!important;caret-color:#ffff8d!important}.v-application .yellow.accent-2{background-color:#ff0!important;border-color:#ff0!important}.v-application .yellow--text.text--accent-2{color:#ff0!important;caret-color:#ff0!important}.v-application .yellow.accent-3{background-color:#ffea00!important;border-color:#ffea00!important}.v-application .yellow--text.text--accent-3{color:#ffea00!important;caret-color:#ffea00!important}.v-application .yellow.accent-4{background-color:#ffd600!important;border-color:#ffd600!important}.v-application .yellow--text.text--accent-4{color:#ffd600!important;caret-color:#ffd600!important}.v-application .amber{background-color:#ffc107!important;border-color:#ffc107!important}.v-application .amber--text{color:#ffc107!important;caret-color:#ffc107!important}.v-application .amber.lighten-5{background-color:#fff8e1!important;border-color:#fff8e1!important}.v-application .amber--text.text--lighten-5{color:#fff8e1!important;caret-color:#fff8e1!important}.v-application .amber.lighten-4{background-color:#ffecb3!important;border-color:#ffecb3!important}.v-application .amber--text.text--lighten-4{color:#ffecb3!important;caret-color:#ffecb3!important}.v-application .amber.lighten-3{background-color:#ffe082!important;border-color:#ffe082!important}.v-application .amber--text.text--lighten-3{color:#ffe082!important;caret-color:#ffe082!important}.v-application .amber.lighten-2{background-color:#ffd54f!important;border-color:#ffd54f!important}.v-application .amber--text.text--lighten-2{color:#ffd54f!important;caret-color:#ffd54f!important}.v-application .amber.lighten-1{background-color:#ffca28!important;border-color:#ffca28!important}.v-application .amber--text.text--lighten-1{color:#ffca28!important;caret-color:#ffca28!important}.v-application .amber.darken-1{background-color:#ffb300!important;border-color:#ffb300!important}.v-application .amber--text.text--darken-1{color:#ffb300!important;caret-color:#ffb300!important}.v-application .amber.darken-2{background-color:#ffa000!important;border-color:#ffa000!important}.v-application .amber--text.text--darken-2{color:#ffa000!important;caret-color:#ffa000!important}.v-application .amber.darken-3{background-color:#ff8f00!important;border-color:#ff8f00!important}.v-application .amber--text.text--darken-3{color:#ff8f00!important;caret-color:#ff8f00!important}.v-application .amber.darken-4{background-color:#ff6f00!important;border-color:#ff6f00!important}.v-application .amber--text.text--darken-4{color:#ff6f00!important;caret-color:#ff6f00!important}.v-application .amber.accent-1{background-color:#ffe57f!important;border-color:#ffe57f!important}.v-application .amber--text.text--accent-1{color:#ffe57f!important;caret-color:#ffe57f!important}.v-application .amber.accent-2{background-color:#ffd740!important;border-color:#ffd740!important}.v-application .amber--text.text--accent-2{color:#ffd740!important;caret-color:#ffd740!important}.v-application .amber.accent-3{background-color:#ffc400!important;border-color:#ffc400!important}.v-application .amber--text.text--accent-3{color:#ffc400!important;caret-color:#ffc400!important}.v-application .amber.accent-4{background-color:#ffab00!important;border-color:#ffab00!important}.v-application .amber--text.text--accent-4{color:#ffab00!important;caret-color:#ffab00!important}.v-application .orange{background-color:#ff9800!important;border-color:#ff9800!important}.v-application .orange--text{color:#ff9800!important;caret-color:#ff9800!important}.v-application .orange.lighten-5{background-color:#fff3e0!important;border-color:#fff3e0!important}.v-application .orange--text.text--lighten-5{color:#fff3e0!important;caret-color:#fff3e0!important}.v-application .orange.lighten-4{background-color:#ffe0b2!important;border-color:#ffe0b2!important}.v-application .orange--text.text--lighten-4{color:#ffe0b2!important;caret-color:#ffe0b2!important}.v-application .orange.lighten-3{background-color:#ffcc80!important;border-color:#ffcc80!important}.v-application .orange--text.text--lighten-3{color:#ffcc80!important;caret-color:#ffcc80!important}.v-application .orange.lighten-2{background-color:#ffb74d!important;border-color:#ffb74d!important}.v-application .orange--text.text--lighten-2{color:#ffb74d!important;caret-color:#ffb74d!important}.v-application .orange.lighten-1{background-color:#ffa726!important;border-color:#ffa726!important}.v-application .orange--text.text--lighten-1{color:#ffa726!important;caret-color:#ffa726!important}.v-application .orange.darken-1{background-color:#fb8c00!important;border-color:#fb8c00!important}.v-application .orange--text.text--darken-1{color:#fb8c00!important;caret-color:#fb8c00!important}.v-application .orange.darken-2{background-color:#f57c00!important;border-color:#f57c00!important}.v-application .orange--text.text--darken-2{color:#f57c00!important;caret-color:#f57c00!important}.v-application .orange.darken-3{background-color:#ef6c00!important;border-color:#ef6c00!important}.v-application .orange--text.text--darken-3{color:#ef6c00!important;caret-color:#ef6c00!important}.v-application .orange.darken-4{background-color:#e65100!important;border-color:#e65100!important}.v-application .orange--text.text--darken-4{color:#e65100!important;caret-color:#e65100!important}.v-application .orange.accent-1{background-color:#ffd180!important;border-color:#ffd180!important}.v-application .orange--text.text--accent-1{color:#ffd180!important;caret-color:#ffd180!important}.v-application .orange.accent-2{background-color:#ffab40!important;border-color:#ffab40!important}.v-application .orange--text.text--accent-2{color:#ffab40!important;caret-color:#ffab40!important}.v-application .orange.accent-3{background-color:#ff9100!important;border-color:#ff9100!important}.v-application .orange--text.text--accent-3{color:#ff9100!important;caret-color:#ff9100!important}.v-application .orange.accent-4{background-color:#ff6d00!important;border-color:#ff6d00!important}.v-application .orange--text.text--accent-4{color:#ff6d00!important;caret-color:#ff6d00!important}.v-application .deep-orange{background-color:#ff5722!important;border-color:#ff5722!important}.v-application .deep-orange--text{color:#ff5722!important;caret-color:#ff5722!important}.v-application .deep-orange.lighten-5{background-color:#fbe9e7!important;border-color:#fbe9e7!important}.v-application .deep-orange--text.text--lighten-5{color:#fbe9e7!important;caret-color:#fbe9e7!important}.v-application .deep-orange.lighten-4{background-color:#ffccbc!important;border-color:#ffccbc!important}.v-application .deep-orange--text.text--lighten-4{color:#ffccbc!important;caret-color:#ffccbc!important}.v-application .deep-orange.lighten-3{background-color:#ffab91!important;border-color:#ffab91!important}.v-application .deep-orange--text.text--lighten-3{color:#ffab91!important;caret-color:#ffab91!important}.v-application .deep-orange.lighten-2{background-color:#ff8a65!important;border-color:#ff8a65!important}.v-application .deep-orange--text.text--lighten-2{color:#ff8a65!important;caret-color:#ff8a65!important}.v-application .deep-orange.lighten-1{background-color:#ff7043!important;border-color:#ff7043!important}.v-application .deep-orange--text.text--lighten-1{color:#ff7043!important;caret-color:#ff7043!important}.v-application .deep-orange.darken-1{background-color:#f4511e!important;border-color:#f4511e!important}.v-application .deep-orange--text.text--darken-1{color:#f4511e!important;caret-color:#f4511e!important}.v-application .deep-orange.darken-2{background-color:#e64a19!important;border-color:#e64a19!important}.v-application .deep-orange--text.text--darken-2{color:#e64a19!important;caret-color:#e64a19!important}.v-application .deep-orange.darken-3{background-color:#d84315!important;border-color:#d84315!important}.v-application .deep-orange--text.text--darken-3{color:#d84315!important;caret-color:#d84315!important}.v-application .deep-orange.darken-4{background-color:#bf360c!important;border-color:#bf360c!important}.v-application .deep-orange--text.text--darken-4{color:#bf360c!important;caret-color:#bf360c!important}.v-application .deep-orange.accent-1{background-color:#ff9e80!important;border-color:#ff9e80!important}.v-application .deep-orange--text.text--accent-1{color:#ff9e80!important;caret-color:#ff9e80!important}.v-application .deep-orange.accent-2{background-color:#ff6e40!important;border-color:#ff6e40!important}.v-application .deep-orange--text.text--accent-2{color:#ff6e40!important;caret-color:#ff6e40!important}.v-application .deep-orange.accent-3{background-color:#ff3d00!important;border-color:#ff3d00!important}.v-application .deep-orange--text.text--accent-3{color:#ff3d00!important;caret-color:#ff3d00!important}.v-application .deep-orange.accent-4{background-color:#dd2c00!important;border-color:#dd2c00!important}.v-application .deep-orange--text.text--accent-4{color:#dd2c00!important;caret-color:#dd2c00!important}.v-application .brown{background-color:#795548!important;border-color:#795548!important}.v-application .brown--text{color:#795548!important;caret-color:#795548!important}.v-application .brown.lighten-5{background-color:#efebe9!important;border-color:#efebe9!important}.v-application .brown--text.text--lighten-5{color:#efebe9!important;caret-color:#efebe9!important}.v-application .brown.lighten-4{background-color:#d7ccc8!important;border-color:#d7ccc8!important}.v-application .brown--text.text--lighten-4{color:#d7ccc8!important;caret-color:#d7ccc8!important}.v-application .brown.lighten-3{background-color:#bcaaa4!important;border-color:#bcaaa4!important}.v-application .brown--text.text--lighten-3{color:#bcaaa4!important;caret-color:#bcaaa4!important}.v-application .brown.lighten-2{background-color:#a1887f!important;border-color:#a1887f!important}.v-application .brown--text.text--lighten-2{color:#a1887f!important;caret-color:#a1887f!important}.v-application .brown.lighten-1{background-color:#8d6e63!important;border-color:#8d6e63!important}.v-application .brown--text.text--lighten-1{color:#8d6e63!important;caret-color:#8d6e63!important}.v-application .brown.darken-1{background-color:#6d4c41!important;border-color:#6d4c41!important}.v-application .brown--text.text--darken-1{color:#6d4c41!important;caret-color:#6d4c41!important}.v-application .brown.darken-2{background-color:#5d4037!important;border-color:#5d4037!important}.v-application .brown--text.text--darken-2{color:#5d4037!important;caret-color:#5d4037!important}.v-application .brown.darken-3{background-color:#4e342e!important;border-color:#4e342e!important}.v-application .brown--text.text--darken-3{color:#4e342e!important;caret-color:#4e342e!important}.v-application .brown.darken-4{background-color:#3e2723!important;border-color:#3e2723!important}.v-application .brown--text.text--darken-4{color:#3e2723!important;caret-color:#3e2723!important}.v-application .blue-grey{background-color:#607d8b!important;border-color:#607d8b!important}.v-application .blue-grey--text{color:#607d8b!important;caret-color:#607d8b!important}.v-application .blue-grey.lighten-5{background-color:#eceff1!important;border-color:#eceff1!important}.v-application .blue-grey--text.text--lighten-5{color:#eceff1!important;caret-color:#eceff1!important}.v-application .blue-grey.lighten-4{background-color:#cfd8dc!important;border-color:#cfd8dc!important}.v-application .blue-grey--text.text--lighten-4{color:#cfd8dc!important;caret-color:#cfd8dc!important}.v-application .blue-grey.lighten-3{background-color:#b0bec5!important;border-color:#b0bec5!important}.v-application .blue-grey--text.text--lighten-3{color:#b0bec5!important;caret-color:#b0bec5!important}.v-application .blue-grey.lighten-2{background-color:#90a4ae!important;border-color:#90a4ae!important}.v-application .blue-grey--text.text--lighten-2{color:#90a4ae!important;caret-color:#90a4ae!important}.v-application .blue-grey.lighten-1{background-color:#78909c!important;border-color:#78909c!important}.v-application .blue-grey--text.text--lighten-1{color:#78909c!important;caret-color:#78909c!important}.v-application .blue-grey.darken-1{background-color:#546e7a!important;border-color:#546e7a!important}.v-application .blue-grey--text.text--darken-1{color:#546e7a!important;caret-color:#546e7a!important}.v-application .blue-grey.darken-2{background-color:#455a64!important;border-color:#455a64!important}.v-application .blue-grey--text.text--darken-2{color:#455a64!important;caret-color:#455a64!important}.v-application .blue-grey.darken-3{background-color:#37474f!important;border-color:#37474f!important}.v-application .blue-grey--text.text--darken-3{color:#37474f!important;caret-color:#37474f!important}.v-application .blue-grey.darken-4{background-color:#263238!important;border-color:#263238!important}.v-application .blue-grey--text.text--darken-4{color:#263238!important;caret-color:#263238!important}.v-application .grey{background-color:#9e9e9e!important;border-color:#9e9e9e!important}.v-application .grey--text{color:#9e9e9e!important;caret-color:#9e9e9e!important}.v-application .grey.lighten-5{background-color:#fafafa!important;border-color:#fafafa!important}.v-application .grey--text.text--lighten-5{color:#fafafa!important;caret-color:#fafafa!important}.v-application .grey.lighten-4{background-color:#f5f5f5!important;border-color:#f5f5f5!important}.v-application .grey--text.text--lighten-4{color:#f5f5f5!important;caret-color:#f5f5f5!important}.v-application .grey.lighten-3{background-color:#eee!important;border-color:#eee!important}.v-application .grey--text.text--lighten-3{color:#eee!important;caret-color:#eee!important}.v-application .grey.lighten-2{background-color:#e0e0e0!important;border-color:#e0e0e0!important}.v-application .grey--text.text--lighten-2{color:#e0e0e0!important;caret-color:#e0e0e0!important}.v-application .grey.lighten-1{background-color:#bdbdbd!important;border-color:#bdbdbd!important}.v-application .grey--text.text--lighten-1{color:#bdbdbd!important;caret-color:#bdbdbd!important}.v-application .grey.darken-1{background-color:#757575!important;border-color:#757575!important}.v-application .grey--text.text--darken-1{color:#757575!important;caret-color:#757575!important}.v-application .grey.darken-2{background-color:#616161!important;border-color:#616161!important}.v-application .grey--text.text--darken-2{color:#616161!important;caret-color:#616161!important}.v-application .grey.darken-3{background-color:#424242!important;border-color:#424242!important}.v-application .grey--text.text--darken-3{color:#424242!important;caret-color:#424242!important}.v-application .grey.darken-4{background-color:#212121!important;border-color:#212121!important}.v-application .grey--text.text--darken-4{color:#212121!important;caret-color:#212121!important}.v-application .shades.black{background-color:#000!important;border-color:#000!important}.v-application .shades--text.text--black{color:#000!important;caret-color:#000!important}.v-application .shades.white{background-color:#fff!important;border-color:#fff!important}.v-application .shades--text.text--white{color:#fff!important;caret-color:#fff!important}.v-application .shades.transparent{background-color:transparent!important;border-color:transparent!important}.v-application .shades--text.text--transparent{color:transparent!important;caret-color:transparent!important}/*! - * ress.css • v2.0.4 - * MIT License - * github.com/filipelinhares/ress - */html{box-sizing:border-box;overflow-y:scroll;-webkit-text-size-adjust:100%;word-break:normal;-moz-tab-size:4;tab-size:4}*,:after,:before{background-repeat:no-repeat;box-sizing:inherit}:after,:before{text-decoration:inherit;vertical-align:inherit}*{padding:0;margin:0}hr{overflow:visible;height:0}details,main{display:block}summary{display:list-item}small{font-size:80%}[hidden]{display:none}abbr[title]{border-bottom:none;text-decoration:underline;text-decoration:underline dotted}a{background-color:transparent}a:active,a:hover{outline-width:0}code,kbd,pre,samp{font-family:monospace,monospace}pre{font-size:1em}b,strong{font-weight:bolder}sub,sup{font-size:75%;line-height:0;position:relative;vertical-align:baseline}sub{bottom:-.25em}sup{top:-.5em}input{border-radius:0}[disabled]{cursor:default}[type=number]::-webkit-inner-spin-button,[type=number]::-webkit-outer-spin-button{height:auto}[type=search]{-webkit-appearance:textfield;outline-offset:-2px}[type=search]::-webkit-search-cancel-button,[type=search]::-webkit-search-decoration{-webkit-appearance:none}textarea{overflow:auto;resize:vertical}button,input,optgroup,select,textarea{font:inherit}optgroup{font-weight:700}button{overflow:visible}button,select{text-transform:none}[role=button],[type=button],[type=reset],[type=submit],button{cursor:pointer;color:inherit}[type=button]::-moz-focus-inner,[type=reset]::-moz-focus-inner,[type=submit]::-moz-focus-inner,button::-moz-focus-inner{border-style:none;padding:0}[type=button]::-moz-focus-inner,[type=reset]::-moz-focus-inner,[type=submit]::-moz-focus-inner,button:-moz-focusring{outline:1px dotted ButtonText}[type=reset],[type=submit],button,html [type=button]{-webkit-appearance:button}button,input,select,textarea{background-color:transparent;border-style:none}select{-moz-appearance:none;-webkit-appearance:none}select::-ms-expand{display:none}select::-ms-value{color:currentColor}legend{border:0;color:inherit;display:table;white-space:normal;max-width:100%}::-webkit-file-upload-button{-webkit-appearance:button;color:inherit;font:inherit}img{border-style:none}progress{vertical-align:baseline}@media screen{[hidden~=screen]{display:inherit}[hidden~=screen]:not(:active):not(:focus):not(:target){position:absolute!important;clip:rect(0 0 0 0)!important}}[aria-busy=true]{cursor:progress}[aria-controls]{cursor:pointer}[aria-disabled=true]{cursor:default}.v-application .elevation-24{box-shadow:0 11px 15px -7px rgba(0,0,0,.2),0 24px 38px 3px rgba(0,0,0,.14),0 9px 46px 8px rgba(0,0,0,.12)!important}.v-application .elevation-23{box-shadow:0 11px 14px -7px rgba(0,0,0,.2),0 23px 36px 3px rgba(0,0,0,.14),0 9px 44px 8px rgba(0,0,0,.12)!important}.v-application .elevation-22{box-shadow:0 10px 14px -6px rgba(0,0,0,.2),0 22px 35px 3px rgba(0,0,0,.14),0 8px 42px 7px rgba(0,0,0,.12)!important}.v-application .elevation-21{box-shadow:0 10px 13px -6px rgba(0,0,0,.2),0 21px 33px 3px rgba(0,0,0,.14),0 8px 40px 7px rgba(0,0,0,.12)!important}.v-application .elevation-20{box-shadow:0 10px 13px -6px rgba(0,0,0,.2),0 20px 31px 3px rgba(0,0,0,.14),0 8px 38px 7px rgba(0,0,0,.12)!important}.v-application .elevation-19{box-shadow:0 9px 12px -6px rgba(0,0,0,.2),0 19px 29px 2px rgba(0,0,0,.14),0 7px 36px 6px rgba(0,0,0,.12)!important}.v-application .elevation-18{box-shadow:0 9px 11px -5px rgba(0,0,0,.2),0 18px 28px 2px rgba(0,0,0,.14),0 7px 34px 6px rgba(0,0,0,.12)!important}.v-application .elevation-17{box-shadow:0 8px 11px -5px rgba(0,0,0,.2),0 17px 26px 2px rgba(0,0,0,.14),0 6px 32px 5px rgba(0,0,0,.12)!important}.v-application .elevation-16{box-shadow:0 8px 10px -5px rgba(0,0,0,.2),0 16px 24px 2px rgba(0,0,0,.14),0 6px 30px 5px rgba(0,0,0,.12)!important}.v-application .elevation-15{box-shadow:0 8px 9px -5px rgba(0,0,0,.2),0 15px 22px 2px rgba(0,0,0,.14),0 6px 28px 5px rgba(0,0,0,.12)!important}.v-application .elevation-14{box-shadow:0 7px 9px -4px rgba(0,0,0,.2),0 14px 21px 2px rgba(0,0,0,.14),0 5px 26px 4px rgba(0,0,0,.12)!important}.v-application .elevation-13{box-shadow:0 7px 8px -4px rgba(0,0,0,.2),0 13px 19px 2px rgba(0,0,0,.14),0 5px 24px 4px rgba(0,0,0,.12)!important}.v-application .elevation-12{box-shadow:0 7px 8px -4px rgba(0,0,0,.2),0 12px 17px 2px rgba(0,0,0,.14),0 5px 22px 4px rgba(0,0,0,.12)!important}.v-application .elevation-11{box-shadow:0 6px 7px -4px rgba(0,0,0,.2),0 11px 15px 1px rgba(0,0,0,.14),0 4px 20px 3px rgba(0,0,0,.12)!important}.v-application .elevation-10{box-shadow:0 6px 6px -3px rgba(0,0,0,.2),0 10px 14px 1px rgba(0,0,0,.14),0 4px 18px 3px rgba(0,0,0,.12)!important}.v-application .elevation-9{box-shadow:0 5px 6px -3px rgba(0,0,0,.2),0 9px 12px 1px rgba(0,0,0,.14),0 3px 16px 2px rgba(0,0,0,.12)!important}.v-application .elevation-8{box-shadow:0 5px 5px -3px rgba(0,0,0,.2),0 8px 10px 1px rgba(0,0,0,.14),0 3px 14px 2px rgba(0,0,0,.12)!important}.v-application .elevation-7{box-shadow:0 4px 5px -2px rgba(0,0,0,.2),0 7px 10px 1px rgba(0,0,0,.14),0 2px 16px 1px rgba(0,0,0,.12)!important}.v-application .elevation-6{box-shadow:0 3px 5px -1px rgba(0,0,0,.2),0 6px 10px 0 rgba(0,0,0,.14),0 1px 18px 0 rgba(0,0,0,.12)!important}.v-application .elevation-5{box-shadow:0 3px 5px -1px rgba(0,0,0,.2),0 5px 8px 0 rgba(0,0,0,.14),0 1px 14px 0 rgba(0,0,0,.12)!important}.v-application .elevation-4{box-shadow:0 2px 4px -1px rgba(0,0,0,.2),0 4px 5px 0 rgba(0,0,0,.14),0 1px 10px 0 rgba(0,0,0,.12)!important}.v-application .elevation-3{box-shadow:0 3px 3px -2px rgba(0,0,0,.2),0 3px 4px 0 rgba(0,0,0,.14),0 1px 8px 0 rgba(0,0,0,.12)!important}.v-application .elevation-2{box-shadow:0 3px 1px -2px rgba(0,0,0,.2),0 2px 2px 0 rgba(0,0,0,.14),0 1px 5px 0 rgba(0,0,0,.12)!important}.v-application .elevation-1{box-shadow:0 2px 1px -1px rgba(0,0,0,.2),0 1px 1px 0 rgba(0,0,0,.14),0 1px 3px 0 rgba(0,0,0,.12)!important}.v-application .elevation-0{box-shadow:0 0 0 0 rgba(0,0,0,.2),0 0 0 0 rgba(0,0,0,.14),0 0 0 0 rgba(0,0,0,.12)!important}.v-application .carousel-transition-enter{transform:translate(100%)}.v-application .carousel-transition-leave,.v-application .carousel-transition-leave-to{position:absolute;top:0;transform:translate(-100%)}.carousel-reverse-transition-enter{transform:translate(-100%)}.carousel-reverse-transition-leave,.carousel-reverse-transition-leave-to{position:absolute;top:0;transform:translate(100%)}.dialog-transition-enter,.dialog-transition-leave-to{transform:scale(.5);opacity:0}.dialog-transition-enter-to,.dialog-transition-leave{opacity:1}.dialog-bottom-transition-enter,.dialog-bottom-transition-leave-to{transform:translateY(100%)}.dialog-top-transition-enter,.dialog-top-transition-leave-to{transform:translateY(-100%)}.picker-reverse-transition-enter-active,.picker-reverse-transition-leave-active,.picker-transition-enter-active,.picker-transition-leave-active{transition:.3s cubic-bezier(0,0,.2,1)}.picker-reverse-transition-enter,.picker-reverse-transition-leave-to,.picker-transition-enter,.picker-transition-leave-to{opacity:0}.picker-reverse-transition-leave,.picker-reverse-transition-leave-active,.picker-reverse-transition-leave-to,.picker-transition-leave,.picker-transition-leave-active,.picker-transition-leave-to{position:absolute!important}.picker-transition-enter{transform:translateY(100%)}.picker-reverse-transition-enter,.picker-transition-leave-to{transform:translateY(-100%)}.picker-reverse-transition-leave-to{transform:translateY(100%)}.picker-title-transition-enter-to,.picker-title-transition-leave{transform:translate(0)}.picker-title-transition-enter{transform:translate(-100%)}.picker-title-transition-leave-to{opacity:0;transform:translate(100%)}.picker-title-transition-leave,.picker-title-transition-leave-active,.picker-title-transition-leave-to{position:absolute!important}.tab-transition-enter{transform:translate(100%)}.tab-transition-leave,.tab-transition-leave-active{position:absolute;top:0}.tab-transition-leave-to{position:absolute}.tab-reverse-transition-enter,.tab-transition-leave-to{transform:translate(-100%)}.tab-reverse-transition-leave,.tab-reverse-transition-leave-to{top:0;position:absolute;transform:translate(100%)}.expand-transition-enter-active,.expand-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.expand-transition-move{transition:transform .6s}.expand-x-transition-enter-active,.expand-x-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.expand-x-transition-move{transition:transform .6s}.scale-transition-enter-active,.scale-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.scale-transition-move{transition:transform .6s}.scale-transition-enter,.scale-transition-leave,.scale-transition-leave-to{opacity:0;transform:scale(0)}.scale-rotate-transition-enter-active,.scale-rotate-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.scale-rotate-transition-move{transition:transform .6s}.scale-rotate-transition-enter,.scale-rotate-transition-leave,.scale-rotate-transition-leave-to{opacity:0;transform:scale(0) rotate(-45deg)}.scale-rotate-reverse-transition-enter-active,.scale-rotate-reverse-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.scale-rotate-reverse-transition-move{transition:transform .6s}.scale-rotate-reverse-transition-enter,.scale-rotate-reverse-transition-leave,.scale-rotate-reverse-transition-leave-to{opacity:0;transform:scale(0) rotate(45deg)}.message-transition-enter-active,.message-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.message-transition-move{transition:transform .6s}.message-transition-enter,.message-transition-leave-to{opacity:0;transform:translateY(-15px)}.message-transition-leave,.message-transition-leave-active{position:absolute}.slide-y-transition-enter-active,.slide-y-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.slide-y-transition-move{transition:transform .6s}.slide-y-transition-enter,.slide-y-transition-leave-to{opacity:0;transform:translateY(-15px)}.slide-y-reverse-transition-enter-active,.slide-y-reverse-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.slide-y-reverse-transition-move{transition:transform .6s}.slide-y-reverse-transition-enter,.slide-y-reverse-transition-leave-to{opacity:0;transform:translateY(15px)}.scroll-y-transition-enter-active,.scroll-y-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.scroll-y-transition-move{transition:transform .6s}.scroll-y-transition-enter,.scroll-y-transition-leave-to{opacity:0}.scroll-y-transition-enter{transform:translateY(-15px)}.scroll-y-transition-leave-to{transform:translateY(15px)}.scroll-y-reverse-transition-enter-active,.scroll-y-reverse-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.scroll-y-reverse-transition-move{transition:transform .6s}.scroll-y-reverse-transition-enter,.scroll-y-reverse-transition-leave-to{opacity:0}.scroll-y-reverse-transition-enter{transform:translateY(15px)}.scroll-y-reverse-transition-leave-to{transform:translateY(-15px)}.scroll-x-transition-enter-active,.scroll-x-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.scroll-x-transition-move{transition:transform .6s}.scroll-x-transition-enter,.scroll-x-transition-leave-to{opacity:0}.scroll-x-transition-enter{transform:translateX(-15px)}.scroll-x-transition-leave-to{transform:translateX(15px)}.scroll-x-reverse-transition-enter-active,.scroll-x-reverse-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.scroll-x-reverse-transition-move{transition:transform .6s}.scroll-x-reverse-transition-enter,.scroll-x-reverse-transition-leave-to{opacity:0}.scroll-x-reverse-transition-enter{transform:translateX(15px)}.scroll-x-reverse-transition-leave-to{transform:translateX(-15px)}.slide-x-transition-enter-active,.slide-x-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.slide-x-transition-move{transition:transform .6s}.slide-x-transition-enter,.slide-x-transition-leave-to{opacity:0;transform:translateX(-15px)}.slide-x-reverse-transition-enter-active,.slide-x-reverse-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.slide-x-reverse-transition-move{transition:transform .6s}.slide-x-reverse-transition-enter,.slide-x-reverse-transition-leave-to{opacity:0;transform:translateX(15px)}.fade-transition-enter-active,.fade-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.fade-transition-move{transition:transform .6s}.fade-transition-enter,.fade-transition-leave-to{opacity:0!important}.fab-transition-enter-active,.fab-transition-leave-active{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.fab-transition-move{transition:transform .6s}.fab-transition-enter,.fab-transition-leave-to{transform:scale(0) rotate(-45deg)}.v-application .blockquote{padding:16px 0 16px 24px;font-size:18px;font-weight:300}.v-application code,.v-application kbd{border-radius:3px;font-size:85%;font-weight:400}.v-application code{padding:.2em .4em}.v-application kbd{padding:.2em .4rem;box-shadow:0 3px 1px -2px rgba(0,0,0,.2),0 2px 2px 0 rgba(0,0,0,.14),0 1px 5px 0 rgba(0,0,0,.12)}.theme--light.v-application code{background-color:rgba(0,0,0,.05);color:currentColor}.theme--light.v-application kbd{background:#212529;color:#fff}.theme--dark.v-application code{background-color:hsla(0,0%,100%,.1);color:currentColor}.theme--dark.v-application kbd{background:#212529;color:#fff}html{font-size:16px;overflow-x:hidden;text-rendering:optimizeLegibility;-webkit-font-smoothing:antialiased;-moz-osx-font-smoothing:grayscale;-webkit-tap-highlight-color:rgba(0,0,0,0)}html.overflow-y-hidden{overflow-y:hidden!important}.v-application{font-family:Roboto,sans-serif;line-height:1.5}.v-application ::-ms-clear,.v-application ::-ms-reveal{display:none}@supports(-webkit-touch-callout:none){body{cursor:pointer}}.v-application .theme--light.heading{color:rgba(0,0,0,.87)}.v-application .theme--dark.heading{color:#fff}.v-application ol,.v-application ul{padding-left:24px}.v-application .display-4{font-size:6rem!important;line-height:6rem;letter-spacing:-.015625em!important}.v-application .display-3,.v-application .display-4{font-weight:300;font-family:Roboto,sans-serif!important}.v-application .display-3{font-size:3.75rem!important;line-height:3.75rem;letter-spacing:-.0083333333em!important}.v-application .display-2{font-size:3rem!important;line-height:3.125rem;letter-spacing:normal!important}.v-application .display-1,.v-application .display-2{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .display-1{font-size:2.125rem!important;line-height:2.5rem;letter-spacing:.0073529412em!important}.v-application .headline{font-size:1.5rem!important;font-weight:400;letter-spacing:normal!important}.v-application .headline,.v-application .title{line-height:2rem;font-family:Roboto,sans-serif!important}.v-application .title{font-size:1.25rem!important;font-weight:500;letter-spacing:.0125em!important}.v-application .subtitle-2{font-size:.875rem!important;font-weight:500;letter-spacing:.0071428571em!important;line-height:1.375rem;font-family:Roboto,sans-serif!important}.v-application .subtitle-1{font-size:1rem!important;letter-spacing:.009375em!important;line-height:1.75rem}.v-application .body-2,.v-application .subtitle-1{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .body-2{font-size:.875rem!important;letter-spacing:.0178571429em!important;line-height:1.25rem}.v-application .body-1{font-size:1rem!important;letter-spacing:.03125em!important;line-height:1.5rem}.v-application .body-1,.v-application .caption{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .caption{font-size:.75rem!important;letter-spacing:.0333333333em!important;line-height:1.25rem}.v-application .overline{font-size:.75rem!important;font-weight:500;letter-spacing:.1666666667em!important;line-height:2rem;text-transform:uppercase;font-family:Roboto,sans-serif!important}.v-application p{margin-bottom:16px}@media only print{.v-application .hidden-print-only{display:none!important}}@media only screen{.v-application .hidden-screen-only{display:none!important}}@media only screen and (max-width:599px){.v-application .hidden-xs-only{display:none!important}}@media only screen and (min-width:600px)and (max-width:959px){.v-application .hidden-sm-only{display:none!important}}@media only screen and (max-width:959px){.v-application .hidden-sm-and-down{display:none!important}}@media only screen and (min-width:600px){.v-application .hidden-sm-and-up{display:none!important}}@media only screen and (min-width:960px)and (max-width:1263px){.v-application .hidden-md-only{display:none!important}}@media only screen and (max-width:1263px){.v-application .hidden-md-and-down{display:none!important}}@media only screen and (min-width:960px){.v-application .hidden-md-and-up{display:none!important}}@media only screen and (min-width:1264px)and (max-width:1903px){.v-application .hidden-lg-only{display:none!important}}@media only screen and (max-width:1903px){.v-application .hidden-lg-and-down{display:none!important}}@media only screen and (min-width:1264px){.v-application .hidden-lg-and-up{display:none!important}}@media only screen and (min-width:1904px){.v-application .hidden-xl-only{display:none!important}}.d-sr-only,.d-sr-only-focusable:not(:focus){border:0!important;clip:rect(0,0,0,0)!important;height:1px!important;margin:-1px!important;overflow:hidden!important;padding:0!important;position:absolute!important;white-space:nowrap!important;width:1px!important}.v-application .font-weight-thin{font-weight:100!important}.v-application .font-weight-light{font-weight:300!important}.v-application .font-weight-regular{font-weight:400!important}.v-application .font-weight-medium{font-weight:500!important}.v-application .font-weight-bold{font-weight:700!important}.v-application .font-weight-black{font-weight:900!important}.v-application .font-italic{font-style:italic!important}.v-application .transition-fast-out-slow-in{transition:.3s cubic-bezier(.4,0,.2,1)!important}.v-application .transition-linear-out-slow-in{transition:.3s cubic-bezier(0,0,.2,1)!important}.v-application .transition-fast-out-linear-in{transition:.3s cubic-bezier(.4,0,1,1)!important}.v-application .transition-ease-in-out{transition:.3s cubic-bezier(.4,0,.6,1)!important}.v-application .transition-fast-in-fast-out{transition:.3s cubic-bezier(.25,.8,.25,1)!important}.v-application .transition-swing{transition:.3s cubic-bezier(.25,.8,.5,1)!important}.v-application .overflow-auto{overflow:auto!important}.v-application .overflow-hidden{overflow:hidden!important}.v-application .overflow-visible{overflow:visible!important}.v-application .overflow-x-auto{overflow-x:auto!important}.v-application .overflow-x-hidden{overflow-x:hidden!important}.v-application .overflow-y-auto{overflow-y:auto!important}.v-application .overflow-y-hidden{overflow-y:hidden!important}.v-application .d-none{display:none!important}.v-application .d-inline{display:inline!important}.v-application .d-inline-block{display:inline-block!important}.v-application .d-block{display:block!important}.v-application .d-table{display:table!important}.v-application .d-table-row{display:table-row!important}.v-application .d-table-cell{display:table-cell!important}.v-application .d-flex{display:flex!important}.v-application .d-inline-flex{display:inline-flex!important}.v-application .float-none{float:none!important}.v-application .float-left{float:left!important}.v-application .float-right{float:right!important}.v-application--is-rtl .float-end{float:left!important}.v-application--is-ltr .float-end,.v-application--is-rtl .float-start{float:right!important}.v-application--is-ltr .float-start{float:left!important}.v-application .flex-fill{flex:1 1 auto!important}.v-application .flex-row{flex-direction:row!important}.v-application .flex-column{flex-direction:column!important}.v-application .flex-row-reverse{flex-direction:row-reverse!important}.v-application .flex-column-reverse{flex-direction:column-reverse!important}.v-application .flex-grow-0{flex-grow:0!important}.v-application .flex-grow-1{flex-grow:1!important}.v-application .flex-shrink-0{flex-shrink:0!important}.v-application .flex-shrink-1{flex-shrink:1!important}.v-application .flex-wrap{flex-wrap:wrap!important}.v-application .flex-nowrap{flex-wrap:nowrap!important}.v-application .flex-wrap-reverse{flex-wrap:wrap-reverse!important}.v-application .justify-start{justify-content:flex-start!important}.v-application .justify-end{justify-content:flex-end!important}.v-application .justify-center{justify-content:center!important}.v-application .justify-space-between{justify-content:space-between!important}.v-application .justify-space-around{justify-content:space-around!important}.v-application .align-start{align-items:flex-start!important}.v-application .align-end{align-items:flex-end!important}.v-application .align-center{align-items:center!important}.v-application .align-baseline{align-items:baseline!important}.v-application .align-stretch{align-items:stretch!important}.v-application .align-content-start{align-content:flex-start!important}.v-application .align-content-end{align-content:flex-end!important}.v-application .align-content-center{align-content:center!important}.v-application .align-content-space-between{align-content:space-between!important}.v-application .align-content-space-around{align-content:space-around!important}.v-application .align-content-stretch{align-content:stretch!important}.v-application .align-self-auto{align-self:auto!important}.v-application .align-self-start{align-self:flex-start!important}.v-application .align-self-end{align-self:flex-end!important}.v-application .align-self-center{align-self:center!important}.v-application .align-self-baseline{align-self:baseline!important}.v-application .align-self-stretch{align-self:stretch!important}.v-application .order-first{order:-1!important}.v-application .order-0{order:0!important}.v-application .order-1{order:1!important}.v-application .order-2{order:2!important}.v-application .order-3{order:3!important}.v-application .order-4{order:4!important}.v-application .order-5{order:5!important}.v-application .order-6{order:6!important}.v-application .order-7{order:7!important}.v-application .order-8{order:8!important}.v-application .order-9{order:9!important}.v-application .order-10{order:10!important}.v-application .order-11{order:11!important}.v-application .order-12{order:12!important}.v-application .order-last{order:13!important}.v-application .ma-0{margin:0!important}.v-application .ma-1{margin:4px!important}.v-application .ma-2{margin:8px!important}.v-application .ma-3{margin:12px!important}.v-application .ma-4{margin:16px!important}.v-application .ma-5{margin:20px!important}.v-application .ma-6{margin:24px!important}.v-application .ma-7{margin:28px!important}.v-application .ma-8{margin:32px!important}.v-application .ma-9{margin:36px!important}.v-application .ma-10{margin:40px!important}.v-application .ma-11{margin:44px!important}.v-application .ma-12{margin:48px!important}.v-application .ma-13{margin:52px!important}.v-application .ma-14{margin:56px!important}.v-application .ma-15{margin:60px!important}.v-application .ma-16{margin:64px!important}.v-application .ma-auto{margin:auto!important}.v-application .mx-0{margin-right:0!important;margin-left:0!important}.v-application .mx-1{margin-right:4px!important;margin-left:4px!important}.v-application .mx-2{margin-right:8px!important;margin-left:8px!important}.v-application .mx-3{margin-right:12px!important;margin-left:12px!important}.v-application .mx-4{margin-right:16px!important;margin-left:16px!important}.v-application .mx-5{margin-right:20px!important;margin-left:20px!important}.v-application .mx-6{margin-right:24px!important;margin-left:24px!important}.v-application .mx-7{margin-right:28px!important;margin-left:28px!important}.v-application .mx-8{margin-right:32px!important;margin-left:32px!important}.v-application .mx-9{margin-right:36px!important;margin-left:36px!important}.v-application .mx-10{margin-right:40px!important;margin-left:40px!important}.v-application .mx-11{margin-right:44px!important;margin-left:44px!important}.v-application .mx-12{margin-right:48px!important;margin-left:48px!important}.v-application .mx-13{margin-right:52px!important;margin-left:52px!important}.v-application .mx-14{margin-right:56px!important;margin-left:56px!important}.v-application .mx-15{margin-right:60px!important;margin-left:60px!important}.v-application .mx-16{margin-right:64px!important;margin-left:64px!important}.v-application .mx-auto{margin-right:auto!important;margin-left:auto!important}.v-application .my-0{margin-top:0!important;margin-bottom:0!important}.v-application .my-1{margin-top:4px!important;margin-bottom:4px!important}.v-application .my-2{margin-top:8px!important;margin-bottom:8px!important}.v-application .my-3{margin-top:12px!important;margin-bottom:12px!important}.v-application .my-4{margin-top:16px!important;margin-bottom:16px!important}.v-application .my-5{margin-top:20px!important;margin-bottom:20px!important}.v-application .my-6{margin-top:24px!important;margin-bottom:24px!important}.v-application .my-7{margin-top:28px!important;margin-bottom:28px!important}.v-application .my-8{margin-top:32px!important;margin-bottom:32px!important}.v-application .my-9{margin-top:36px!important;margin-bottom:36px!important}.v-application .my-10{margin-top:40px!important;margin-bottom:40px!important}.v-application .my-11{margin-top:44px!important;margin-bottom:44px!important}.v-application .my-12{margin-top:48px!important;margin-bottom:48px!important}.v-application .my-13{margin-top:52px!important;margin-bottom:52px!important}.v-application .my-14{margin-top:56px!important;margin-bottom:56px!important}.v-application .my-15{margin-top:60px!important;margin-bottom:60px!important}.v-application .my-16{margin-top:64px!important;margin-bottom:64px!important}.v-application .my-auto{margin-top:auto!important;margin-bottom:auto!important}.v-application .mt-0{margin-top:0!important}.v-application .mt-1{margin-top:4px!important}.v-application .mt-2{margin-top:8px!important}.v-application .mt-3{margin-top:12px!important}.v-application .mt-4{margin-top:16px!important}.v-application .mt-5{margin-top:20px!important}.v-application .mt-6{margin-top:24px!important}.v-application .mt-7{margin-top:28px!important}.v-application .mt-8{margin-top:32px!important}.v-application .mt-9{margin-top:36px!important}.v-application .mt-10{margin-top:40px!important}.v-application .mt-11{margin-top:44px!important}.v-application .mt-12{margin-top:48px!important}.v-application .mt-13{margin-top:52px!important}.v-application .mt-14{margin-top:56px!important}.v-application .mt-15{margin-top:60px!important}.v-application .mt-16{margin-top:64px!important}.v-application .mt-auto{margin-top:auto!important}.v-application .mr-0{margin-right:0!important}.v-application .mr-1{margin-right:4px!important}.v-application .mr-2{margin-right:8px!important}.v-application .mr-3{margin-right:12px!important}.v-application .mr-4{margin-right:16px!important}.v-application .mr-5{margin-right:20px!important}.v-application .mr-6{margin-right:24px!important}.v-application .mr-7{margin-right:28px!important}.v-application .mr-8{margin-right:32px!important}.v-application .mr-9{margin-right:36px!important}.v-application .mr-10{margin-right:40px!important}.v-application .mr-11{margin-right:44px!important}.v-application .mr-12{margin-right:48px!important}.v-application .mr-13{margin-right:52px!important}.v-application .mr-14{margin-right:56px!important}.v-application .mr-15{margin-right:60px!important}.v-application .mr-16{margin-right:64px!important}.v-application .mr-auto{margin-right:auto!important}.v-application .mb-0{margin-bottom:0!important}.v-application .mb-1{margin-bottom:4px!important}.v-application .mb-2{margin-bottom:8px!important}.v-application .mb-3{margin-bottom:12px!important}.v-application .mb-4{margin-bottom:16px!important}.v-application .mb-5{margin-bottom:20px!important}.v-application .mb-6{margin-bottom:24px!important}.v-application .mb-7{margin-bottom:28px!important}.v-application .mb-8{margin-bottom:32px!important}.v-application .mb-9{margin-bottom:36px!important}.v-application .mb-10{margin-bottom:40px!important}.v-application .mb-11{margin-bottom:44px!important}.v-application .mb-12{margin-bottom:48px!important}.v-application .mb-13{margin-bottom:52px!important}.v-application .mb-14{margin-bottom:56px!important}.v-application .mb-15{margin-bottom:60px!important}.v-application .mb-16{margin-bottom:64px!important}.v-application .mb-auto{margin-bottom:auto!important}.v-application .ml-0{margin-left:0!important}.v-application .ml-1{margin-left:4px!important}.v-application .ml-2{margin-left:8px!important}.v-application .ml-3{margin-left:12px!important}.v-application .ml-4{margin-left:16px!important}.v-application .ml-5{margin-left:20px!important}.v-application .ml-6{margin-left:24px!important}.v-application .ml-7{margin-left:28px!important}.v-application .ml-8{margin-left:32px!important}.v-application .ml-9{margin-left:36px!important}.v-application .ml-10{margin-left:40px!important}.v-application .ml-11{margin-left:44px!important}.v-application .ml-12{margin-left:48px!important}.v-application .ml-13{margin-left:52px!important}.v-application .ml-14{margin-left:56px!important}.v-application .ml-15{margin-left:60px!important}.v-application .ml-16{margin-left:64px!important}.v-application .ml-auto{margin-left:auto!important}.v-application--is-ltr .ms-0{margin-left:0!important}.v-application--is-rtl .ms-0{margin-right:0!important}.v-application--is-ltr .ms-1{margin-left:4px!important}.v-application--is-rtl .ms-1{margin-right:4px!important}.v-application--is-ltr .ms-2{margin-left:8px!important}.v-application--is-rtl .ms-2{margin-right:8px!important}.v-application--is-ltr .ms-3{margin-left:12px!important}.v-application--is-rtl .ms-3{margin-right:12px!important}.v-application--is-ltr .ms-4{margin-left:16px!important}.v-application--is-rtl .ms-4{margin-right:16px!important}.v-application--is-ltr .ms-5{margin-left:20px!important}.v-application--is-rtl .ms-5{margin-right:20px!important}.v-application--is-ltr .ms-6{margin-left:24px!important}.v-application--is-rtl .ms-6{margin-right:24px!important}.v-application--is-ltr .ms-7{margin-left:28px!important}.v-application--is-rtl .ms-7{margin-right:28px!important}.v-application--is-ltr .ms-8{margin-left:32px!important}.v-application--is-rtl .ms-8{margin-right:32px!important}.v-application--is-ltr .ms-9{margin-left:36px!important}.v-application--is-rtl .ms-9{margin-right:36px!important}.v-application--is-ltr .ms-10{margin-left:40px!important}.v-application--is-rtl .ms-10{margin-right:40px!important}.v-application--is-ltr .ms-11{margin-left:44px!important}.v-application--is-rtl .ms-11{margin-right:44px!important}.v-application--is-ltr .ms-12{margin-left:48px!important}.v-application--is-rtl .ms-12{margin-right:48px!important}.v-application--is-ltr .ms-13{margin-left:52px!important}.v-application--is-rtl .ms-13{margin-right:52px!important}.v-application--is-ltr .ms-14{margin-left:56px!important}.v-application--is-rtl .ms-14{margin-right:56px!important}.v-application--is-ltr .ms-15{margin-left:60px!important}.v-application--is-rtl .ms-15{margin-right:60px!important}.v-application--is-ltr .ms-16{margin-left:64px!important}.v-application--is-rtl .ms-16{margin-right:64px!important}.v-application--is-ltr .ms-auto{margin-left:auto!important}.v-application--is-rtl .ms-auto{margin-right:auto!important}.v-application--is-ltr .me-0{margin-right:0!important}.v-application--is-rtl .me-0{margin-left:0!important}.v-application--is-ltr .me-1{margin-right:4px!important}.v-application--is-rtl .me-1{margin-left:4px!important}.v-application--is-ltr .me-2{margin-right:8px!important}.v-application--is-rtl .me-2{margin-left:8px!important}.v-application--is-ltr .me-3{margin-right:12px!important}.v-application--is-rtl .me-3{margin-left:12px!important}.v-application--is-ltr .me-4{margin-right:16px!important}.v-application--is-rtl .me-4{margin-left:16px!important}.v-application--is-ltr .me-5{margin-right:20px!important}.v-application--is-rtl .me-5{margin-left:20px!important}.v-application--is-ltr .me-6{margin-right:24px!important}.v-application--is-rtl .me-6{margin-left:24px!important}.v-application--is-ltr .me-7{margin-right:28px!important}.v-application--is-rtl .me-7{margin-left:28px!important}.v-application--is-ltr .me-8{margin-right:32px!important}.v-application--is-rtl .me-8{margin-left:32px!important}.v-application--is-ltr .me-9{margin-right:36px!important}.v-application--is-rtl .me-9{margin-left:36px!important}.v-application--is-ltr .me-10{margin-right:40px!important}.v-application--is-rtl .me-10{margin-left:40px!important}.v-application--is-ltr .me-11{margin-right:44px!important}.v-application--is-rtl .me-11{margin-left:44px!important}.v-application--is-ltr .me-12{margin-right:48px!important}.v-application--is-rtl .me-12{margin-left:48px!important}.v-application--is-ltr .me-13{margin-right:52px!important}.v-application--is-rtl .me-13{margin-left:52px!important}.v-application--is-ltr .me-14{margin-right:56px!important}.v-application--is-rtl .me-14{margin-left:56px!important}.v-application--is-ltr .me-15{margin-right:60px!important}.v-application--is-rtl .me-15{margin-left:60px!important}.v-application--is-ltr .me-16{margin-right:64px!important}.v-application--is-rtl .me-16{margin-left:64px!important}.v-application--is-ltr .me-auto{margin-right:auto!important}.v-application--is-rtl .me-auto{margin-left:auto!important}.v-application .ma-n1{margin:-4px!important}.v-application .ma-n2{margin:-8px!important}.v-application .ma-n3{margin:-12px!important}.v-application .ma-n4{margin:-16px!important}.v-application .ma-n5{margin:-20px!important}.v-application .ma-n6{margin:-24px!important}.v-application .ma-n7{margin:-28px!important}.v-application .ma-n8{margin:-32px!important}.v-application .ma-n9{margin:-36px!important}.v-application .ma-n10{margin:-40px!important}.v-application .ma-n11{margin:-44px!important}.v-application .ma-n12{margin:-48px!important}.v-application .ma-n13{margin:-52px!important}.v-application .ma-n14{margin:-56px!important}.v-application .ma-n15{margin:-60px!important}.v-application .ma-n16{margin:-64px!important}.v-application .mx-n1{margin-right:-4px!important;margin-left:-4px!important}.v-application .mx-n2{margin-right:-8px!important;margin-left:-8px!important}.v-application .mx-n3{margin-right:-12px!important;margin-left:-12px!important}.v-application .mx-n4{margin-right:-16px!important;margin-left:-16px!important}.v-application .mx-n5{margin-right:-20px!important;margin-left:-20px!important}.v-application .mx-n6{margin-right:-24px!important;margin-left:-24px!important}.v-application .mx-n7{margin-right:-28px!important;margin-left:-28px!important}.v-application .mx-n8{margin-right:-32px!important;margin-left:-32px!important}.v-application .mx-n9{margin-right:-36px!important;margin-left:-36px!important}.v-application .mx-n10{margin-right:-40px!important;margin-left:-40px!important}.v-application .mx-n11{margin-right:-44px!important;margin-left:-44px!important}.v-application .mx-n12{margin-right:-48px!important;margin-left:-48px!important}.v-application .mx-n13{margin-right:-52px!important;margin-left:-52px!important}.v-application .mx-n14{margin-right:-56px!important;margin-left:-56px!important}.v-application .mx-n15{margin-right:-60px!important;margin-left:-60px!important}.v-application .mx-n16{margin-right:-64px!important;margin-left:-64px!important}.v-application .my-n1{margin-top:-4px!important;margin-bottom:-4px!important}.v-application .my-n2{margin-top:-8px!important;margin-bottom:-8px!important}.v-application .my-n3{margin-top:-12px!important;margin-bottom:-12px!important}.v-application .my-n4{margin-top:-16px!important;margin-bottom:-16px!important}.v-application .my-n5{margin-top:-20px!important;margin-bottom:-20px!important}.v-application .my-n6{margin-top:-24px!important;margin-bottom:-24px!important}.v-application .my-n7{margin-top:-28px!important;margin-bottom:-28px!important}.v-application .my-n8{margin-top:-32px!important;margin-bottom:-32px!important}.v-application .my-n9{margin-top:-36px!important;margin-bottom:-36px!important}.v-application .my-n10{margin-top:-40px!important;margin-bottom:-40px!important}.v-application .my-n11{margin-top:-44px!important;margin-bottom:-44px!important}.v-application .my-n12{margin-top:-48px!important;margin-bottom:-48px!important}.v-application .my-n13{margin-top:-52px!important;margin-bottom:-52px!important}.v-application .my-n14{margin-top:-56px!important;margin-bottom:-56px!important}.v-application .my-n15{margin-top:-60px!important;margin-bottom:-60px!important}.v-application .my-n16{margin-top:-64px!important;margin-bottom:-64px!important}.v-application .mt-n1{margin-top:-4px!important}.v-application .mt-n2{margin-top:-8px!important}.v-application .mt-n3{margin-top:-12px!important}.v-application .mt-n4{margin-top:-16px!important}.v-application .mt-n5{margin-top:-20px!important}.v-application .mt-n6{margin-top:-24px!important}.v-application .mt-n7{margin-top:-28px!important}.v-application .mt-n8{margin-top:-32px!important}.v-application .mt-n9{margin-top:-36px!important}.v-application .mt-n10{margin-top:-40px!important}.v-application .mt-n11{margin-top:-44px!important}.v-application .mt-n12{margin-top:-48px!important}.v-application .mt-n13{margin-top:-52px!important}.v-application .mt-n14{margin-top:-56px!important}.v-application .mt-n15{margin-top:-60px!important}.v-application .mt-n16{margin-top:-64px!important}.v-application .mr-n1{margin-right:-4px!important}.v-application .mr-n2{margin-right:-8px!important}.v-application .mr-n3{margin-right:-12px!important}.v-application .mr-n4{margin-right:-16px!important}.v-application .mr-n5{margin-right:-20px!important}.v-application .mr-n6{margin-right:-24px!important}.v-application .mr-n7{margin-right:-28px!important}.v-application .mr-n8{margin-right:-32px!important}.v-application .mr-n9{margin-right:-36px!important}.v-application .mr-n10{margin-right:-40px!important}.v-application .mr-n11{margin-right:-44px!important}.v-application .mr-n12{margin-right:-48px!important}.v-application .mr-n13{margin-right:-52px!important}.v-application .mr-n14{margin-right:-56px!important}.v-application .mr-n15{margin-right:-60px!important}.v-application .mr-n16{margin-right:-64px!important}.v-application .mb-n1{margin-bottom:-4px!important}.v-application .mb-n2{margin-bottom:-8px!important}.v-application .mb-n3{margin-bottom:-12px!important}.v-application .mb-n4{margin-bottom:-16px!important}.v-application .mb-n5{margin-bottom:-20px!important}.v-application .mb-n6{margin-bottom:-24px!important}.v-application .mb-n7{margin-bottom:-28px!important}.v-application .mb-n8{margin-bottom:-32px!important}.v-application .mb-n9{margin-bottom:-36px!important}.v-application .mb-n10{margin-bottom:-40px!important}.v-application .mb-n11{margin-bottom:-44px!important}.v-application .mb-n12{margin-bottom:-48px!important}.v-application .mb-n13{margin-bottom:-52px!important}.v-application .mb-n14{margin-bottom:-56px!important}.v-application .mb-n15{margin-bottom:-60px!important}.v-application .mb-n16{margin-bottom:-64px!important}.v-application .ml-n1{margin-left:-4px!important}.v-application .ml-n2{margin-left:-8px!important}.v-application .ml-n3{margin-left:-12px!important}.v-application .ml-n4{margin-left:-16px!important}.v-application .ml-n5{margin-left:-20px!important}.v-application .ml-n6{margin-left:-24px!important}.v-application .ml-n7{margin-left:-28px!important}.v-application .ml-n8{margin-left:-32px!important}.v-application .ml-n9{margin-left:-36px!important}.v-application .ml-n10{margin-left:-40px!important}.v-application .ml-n11{margin-left:-44px!important}.v-application .ml-n12{margin-left:-48px!important}.v-application .ml-n13{margin-left:-52px!important}.v-application .ml-n14{margin-left:-56px!important}.v-application .ml-n15{margin-left:-60px!important}.v-application .ml-n16{margin-left:-64px!important}.v-application--is-ltr .ms-n1{margin-left:-4px!important}.v-application--is-rtl .ms-n1{margin-right:-4px!important}.v-application--is-ltr .ms-n2{margin-left:-8px!important}.v-application--is-rtl .ms-n2{margin-right:-8px!important}.v-application--is-ltr .ms-n3{margin-left:-12px!important}.v-application--is-rtl .ms-n3{margin-right:-12px!important}.v-application--is-ltr .ms-n4{margin-left:-16px!important}.v-application--is-rtl .ms-n4{margin-right:-16px!important}.v-application--is-ltr .ms-n5{margin-left:-20px!important}.v-application--is-rtl .ms-n5{margin-right:-20px!important}.v-application--is-ltr .ms-n6{margin-left:-24px!important}.v-application--is-rtl .ms-n6{margin-right:-24px!important}.v-application--is-ltr .ms-n7{margin-left:-28px!important}.v-application--is-rtl .ms-n7{margin-right:-28px!important}.v-application--is-ltr .ms-n8{margin-left:-32px!important}.v-application--is-rtl .ms-n8{margin-right:-32px!important}.v-application--is-ltr .ms-n9{margin-left:-36px!important}.v-application--is-rtl .ms-n9{margin-right:-36px!important}.v-application--is-ltr .ms-n10{margin-left:-40px!important}.v-application--is-rtl .ms-n10{margin-right:-40px!important}.v-application--is-ltr .ms-n11{margin-left:-44px!important}.v-application--is-rtl .ms-n11{margin-right:-44px!important}.v-application--is-ltr .ms-n12{margin-left:-48px!important}.v-application--is-rtl .ms-n12{margin-right:-48px!important}.v-application--is-ltr .ms-n13{margin-left:-52px!important}.v-application--is-rtl .ms-n13{margin-right:-52px!important}.v-application--is-ltr .ms-n14{margin-left:-56px!important}.v-application--is-rtl .ms-n14{margin-right:-56px!important}.v-application--is-ltr .ms-n15{margin-left:-60px!important}.v-application--is-rtl .ms-n15{margin-right:-60px!important}.v-application--is-ltr .ms-n16{margin-left:-64px!important}.v-application--is-rtl .ms-n16{margin-right:-64px!important}.v-application--is-ltr .me-n1{margin-right:-4px!important}.v-application--is-rtl .me-n1{margin-left:-4px!important}.v-application--is-ltr .me-n2{margin-right:-8px!important}.v-application--is-rtl .me-n2{margin-left:-8px!important}.v-application--is-ltr .me-n3{margin-right:-12px!important}.v-application--is-rtl .me-n3{margin-left:-12px!important}.v-application--is-ltr .me-n4{margin-right:-16px!important}.v-application--is-rtl .me-n4{margin-left:-16px!important}.v-application--is-ltr .me-n5{margin-right:-20px!important}.v-application--is-rtl .me-n5{margin-left:-20px!important}.v-application--is-ltr .me-n6{margin-right:-24px!important}.v-application--is-rtl .me-n6{margin-left:-24px!important}.v-application--is-ltr .me-n7{margin-right:-28px!important}.v-application--is-rtl .me-n7{margin-left:-28px!important}.v-application--is-ltr .me-n8{margin-right:-32px!important}.v-application--is-rtl .me-n8{margin-left:-32px!important}.v-application--is-ltr .me-n9{margin-right:-36px!important}.v-application--is-rtl .me-n9{margin-left:-36px!important}.v-application--is-ltr .me-n10{margin-right:-40px!important}.v-application--is-rtl .me-n10{margin-left:-40px!important}.v-application--is-ltr .me-n11{margin-right:-44px!important}.v-application--is-rtl .me-n11{margin-left:-44px!important}.v-application--is-ltr .me-n12{margin-right:-48px!important}.v-application--is-rtl .me-n12{margin-left:-48px!important}.v-application--is-ltr .me-n13{margin-right:-52px!important}.v-application--is-rtl .me-n13{margin-left:-52px!important}.v-application--is-ltr .me-n14{margin-right:-56px!important}.v-application--is-rtl .me-n14{margin-left:-56px!important}.v-application--is-ltr .me-n15{margin-right:-60px!important}.v-application--is-rtl .me-n15{margin-left:-60px!important}.v-application--is-ltr .me-n16{margin-right:-64px!important}.v-application--is-rtl .me-n16{margin-left:-64px!important}.v-application .pa-0{padding:0!important}.v-application .pa-1{padding:4px!important}.v-application .pa-2{padding:8px!important}.v-application .pa-3{padding:12px!important}.v-application .pa-4{padding:16px!important}.v-application .pa-5{padding:20px!important}.v-application .pa-6{padding:24px!important}.v-application .pa-7{padding:28px!important}.v-application .pa-8{padding:32px!important}.v-application .pa-9{padding:36px!important}.v-application .pa-10{padding:40px!important}.v-application .pa-11{padding:44px!important}.v-application .pa-12{padding:48px!important}.v-application .pa-13{padding:52px!important}.v-application .pa-14{padding:56px!important}.v-application .pa-15{padding:60px!important}.v-application .pa-16{padding:64px!important}.v-application .px-0{padding-right:0!important;padding-left:0!important}.v-application .px-1{padding-right:4px!important;padding-left:4px!important}.v-application .px-2{padding-right:8px!important;padding-left:8px!important}.v-application .px-3{padding-right:12px!important;padding-left:12px!important}.v-application .px-4{padding-right:16px!important;padding-left:16px!important}.v-application .px-5{padding-right:20px!important;padding-left:20px!important}.v-application .px-6{padding-right:24px!important;padding-left:24px!important}.v-application .px-7{padding-right:28px!important;padding-left:28px!important}.v-application .px-8{padding-right:32px!important;padding-left:32px!important}.v-application .px-9{padding-right:36px!important;padding-left:36px!important}.v-application .px-10{padding-right:40px!important;padding-left:40px!important}.v-application .px-11{padding-right:44px!important;padding-left:44px!important}.v-application .px-12{padding-right:48px!important;padding-left:48px!important}.v-application .px-13{padding-right:52px!important;padding-left:52px!important}.v-application .px-14{padding-right:56px!important;padding-left:56px!important}.v-application .px-15{padding-right:60px!important;padding-left:60px!important}.v-application .px-16{padding-right:64px!important;padding-left:64px!important}.v-application .py-0{padding-top:0!important;padding-bottom:0!important}.v-application .py-1{padding-top:4px!important;padding-bottom:4px!important}.v-application .py-2{padding-top:8px!important;padding-bottom:8px!important}.v-application .py-3{padding-top:12px!important;padding-bottom:12px!important}.v-application .py-4{padding-top:16px!important;padding-bottom:16px!important}.v-application .py-5{padding-top:20px!important;padding-bottom:20px!important}.v-application .py-6{padding-top:24px!important;padding-bottom:24px!important}.v-application .py-7{padding-top:28px!important;padding-bottom:28px!important}.v-application .py-8{padding-top:32px!important;padding-bottom:32px!important}.v-application .py-9{padding-top:36px!important;padding-bottom:36px!important}.v-application .py-10{padding-top:40px!important;padding-bottom:40px!important}.v-application .py-11{padding-top:44px!important;padding-bottom:44px!important}.v-application .py-12{padding-top:48px!important;padding-bottom:48px!important}.v-application .py-13{padding-top:52px!important;padding-bottom:52px!important}.v-application .py-14{padding-top:56px!important;padding-bottom:56px!important}.v-application .py-15{padding-top:60px!important;padding-bottom:60px!important}.v-application .py-16{padding-top:64px!important;padding-bottom:64px!important}.v-application .pt-0{padding-top:0!important}.v-application .pt-1{padding-top:4px!important}.v-application .pt-2{padding-top:8px!important}.v-application .pt-3{padding-top:12px!important}.v-application .pt-4{padding-top:16px!important}.v-application .pt-5{padding-top:20px!important}.v-application .pt-6{padding-top:24px!important}.v-application .pt-7{padding-top:28px!important}.v-application .pt-8{padding-top:32px!important}.v-application .pt-9{padding-top:36px!important}.v-application .pt-10{padding-top:40px!important}.v-application .pt-11{padding-top:44px!important}.v-application .pt-12{padding-top:48px!important}.v-application .pt-13{padding-top:52px!important}.v-application .pt-14{padding-top:56px!important}.v-application .pt-15{padding-top:60px!important}.v-application .pt-16{padding-top:64px!important}.v-application .pr-0{padding-right:0!important}.v-application .pr-1{padding-right:4px!important}.v-application .pr-2{padding-right:8px!important}.v-application .pr-3{padding-right:12px!important}.v-application .pr-4{padding-right:16px!important}.v-application .pr-5{padding-right:20px!important}.v-application .pr-6{padding-right:24px!important}.v-application .pr-7{padding-right:28px!important}.v-application .pr-8{padding-right:32px!important}.v-application .pr-9{padding-right:36px!important}.v-application .pr-10{padding-right:40px!important}.v-application .pr-11{padding-right:44px!important}.v-application .pr-12{padding-right:48px!important}.v-application .pr-13{padding-right:52px!important}.v-application .pr-14{padding-right:56px!important}.v-application .pr-15{padding-right:60px!important}.v-application .pr-16{padding-right:64px!important}.v-application .pb-0{padding-bottom:0!important}.v-application .pb-1{padding-bottom:4px!important}.v-application .pb-2{padding-bottom:8px!important}.v-application .pb-3{padding-bottom:12px!important}.v-application .pb-4{padding-bottom:16px!important}.v-application .pb-5{padding-bottom:20px!important}.v-application .pb-6{padding-bottom:24px!important}.v-application .pb-7{padding-bottom:28px!important}.v-application .pb-8{padding-bottom:32px!important}.v-application .pb-9{padding-bottom:36px!important}.v-application .pb-10{padding-bottom:40px!important}.v-application .pb-11{padding-bottom:44px!important}.v-application .pb-12{padding-bottom:48px!important}.v-application .pb-13{padding-bottom:52px!important}.v-application .pb-14{padding-bottom:56px!important}.v-application .pb-15{padding-bottom:60px!important}.v-application .pb-16{padding-bottom:64px!important}.v-application .pl-0{padding-left:0!important}.v-application .pl-1{padding-left:4px!important}.v-application .pl-2{padding-left:8px!important}.v-application .pl-3{padding-left:12px!important}.v-application .pl-4{padding-left:16px!important}.v-application .pl-5{padding-left:20px!important}.v-application .pl-6{padding-left:24px!important}.v-application .pl-7{padding-left:28px!important}.v-application .pl-8{padding-left:32px!important}.v-application .pl-9{padding-left:36px!important}.v-application .pl-10{padding-left:40px!important}.v-application .pl-11{padding-left:44px!important}.v-application .pl-12{padding-left:48px!important}.v-application .pl-13{padding-left:52px!important}.v-application .pl-14{padding-left:56px!important}.v-application .pl-15{padding-left:60px!important}.v-application .pl-16{padding-left:64px!important}.v-application--is-ltr .ps-0{padding-left:0!important}.v-application--is-rtl .ps-0{padding-right:0!important}.v-application--is-ltr .ps-1{padding-left:4px!important}.v-application--is-rtl .ps-1{padding-right:4px!important}.v-application--is-ltr .ps-2{padding-left:8px!important}.v-application--is-rtl .ps-2{padding-right:8px!important}.v-application--is-ltr .ps-3{padding-left:12px!important}.v-application--is-rtl .ps-3{padding-right:12px!important}.v-application--is-ltr .ps-4{padding-left:16px!important}.v-application--is-rtl .ps-4{padding-right:16px!important}.v-application--is-ltr .ps-5{padding-left:20px!important}.v-application--is-rtl .ps-5{padding-right:20px!important}.v-application--is-ltr .ps-6{padding-left:24px!important}.v-application--is-rtl .ps-6{padding-right:24px!important}.v-application--is-ltr .ps-7{padding-left:28px!important}.v-application--is-rtl .ps-7{padding-right:28px!important}.v-application--is-ltr .ps-8{padding-left:32px!important}.v-application--is-rtl .ps-8{padding-right:32px!important}.v-application--is-ltr .ps-9{padding-left:36px!important}.v-application--is-rtl .ps-9{padding-right:36px!important}.v-application--is-ltr .ps-10{padding-left:40px!important}.v-application--is-rtl .ps-10{padding-right:40px!important}.v-application--is-ltr .ps-11{padding-left:44px!important}.v-application--is-rtl .ps-11{padding-right:44px!important}.v-application--is-ltr .ps-12{padding-left:48px!important}.v-application--is-rtl .ps-12{padding-right:48px!important}.v-application--is-ltr .ps-13{padding-left:52px!important}.v-application--is-rtl .ps-13{padding-right:52px!important}.v-application--is-ltr .ps-14{padding-left:56px!important}.v-application--is-rtl .ps-14{padding-right:56px!important}.v-application--is-ltr .ps-15{padding-left:60px!important}.v-application--is-rtl .ps-15{padding-right:60px!important}.v-application--is-ltr .ps-16{padding-left:64px!important}.v-application--is-rtl .ps-16{padding-right:64px!important}.v-application--is-ltr .pe-0{padding-right:0!important}.v-application--is-rtl .pe-0{padding-left:0!important}.v-application--is-ltr .pe-1{padding-right:4px!important}.v-application--is-rtl .pe-1{padding-left:4px!important}.v-application--is-ltr .pe-2{padding-right:8px!important}.v-application--is-rtl .pe-2{padding-left:8px!important}.v-application--is-ltr .pe-3{padding-right:12px!important}.v-application--is-rtl .pe-3{padding-left:12px!important}.v-application--is-ltr .pe-4{padding-right:16px!important}.v-application--is-rtl .pe-4{padding-left:16px!important}.v-application--is-ltr .pe-5{padding-right:20px!important}.v-application--is-rtl .pe-5{padding-left:20px!important}.v-application--is-ltr .pe-6{padding-right:24px!important}.v-application--is-rtl .pe-6{padding-left:24px!important}.v-application--is-ltr .pe-7{padding-right:28px!important}.v-application--is-rtl .pe-7{padding-left:28px!important}.v-application--is-ltr .pe-8{padding-right:32px!important}.v-application--is-rtl .pe-8{padding-left:32px!important}.v-application--is-ltr .pe-9{padding-right:36px!important}.v-application--is-rtl .pe-9{padding-left:36px!important}.v-application--is-ltr .pe-10{padding-right:40px!important}.v-application--is-rtl .pe-10{padding-left:40px!important}.v-application--is-ltr .pe-11{padding-right:44px!important}.v-application--is-rtl .pe-11{padding-left:44px!important}.v-application--is-ltr .pe-12{padding-right:48px!important}.v-application--is-rtl .pe-12{padding-left:48px!important}.v-application--is-ltr .pe-13{padding-right:52px!important}.v-application--is-rtl .pe-13{padding-left:52px!important}.v-application--is-ltr .pe-14{padding-right:56px!important}.v-application--is-rtl .pe-14{padding-left:56px!important}.v-application--is-ltr .pe-15{padding-right:60px!important}.v-application--is-rtl .pe-15{padding-left:60px!important}.v-application--is-ltr .pe-16{padding-right:64px!important}.v-application--is-rtl .pe-16{padding-left:64px!important}.v-application .rounded-0{border-radius:0!important}.v-application .rounded-sm{border-radius:2px!important}.v-application .rounded{border-radius:4px!important}.v-application .rounded-lg{border-radius:8px!important}.v-application .rounded-xl{border-radius:24px!important}.v-application .rounded-pill{border-radius:9999px!important}.v-application .rounded-circle{border-radius:50%!important}.v-application .rounded-t-0{border-top-left-radius:0!important;border-top-right-radius:0!important}.v-application .rounded-t-sm{border-top-left-radius:2px!important;border-top-right-radius:2px!important}.v-application .rounded-t{border-top-left-radius:4px!important;border-top-right-radius:4px!important}.v-application .rounded-t-lg{border-top-left-radius:8px!important;border-top-right-radius:8px!important}.v-application .rounded-t-xl{border-top-left-radius:24px!important;border-top-right-radius:24px!important}.v-application .rounded-t-pill{border-top-left-radius:9999px!important;border-top-right-radius:9999px!important}.v-application .rounded-t-circle{border-top-left-radius:50%!important;border-top-right-radius:50%!important}.v-application .rounded-r-0{border-top-right-radius:0!important;border-bottom-right-radius:0!important}.v-application .rounded-r-sm{border-top-right-radius:2px!important;border-bottom-right-radius:2px!important}.v-application .rounded-r{border-top-right-radius:4px!important;border-bottom-right-radius:4px!important}.v-application .rounded-r-lg{border-top-right-radius:8px!important;border-bottom-right-radius:8px!important}.v-application .rounded-r-xl{border-top-right-radius:24px!important;border-bottom-right-radius:24px!important}.v-application .rounded-r-pill{border-top-right-radius:9999px!important;border-bottom-right-radius:9999px!important}.v-application .rounded-r-circle{border-top-right-radius:50%!important;border-bottom-right-radius:50%!important}.v-application .rounded-b-0{border-bottom-left-radius:0!important;border-bottom-right-radius:0!important}.v-application .rounded-b-sm{border-bottom-left-radius:2px!important;border-bottom-right-radius:2px!important}.v-application .rounded-b{border-bottom-left-radius:4px!important;border-bottom-right-radius:4px!important}.v-application .rounded-b-lg{border-bottom-left-radius:8px!important;border-bottom-right-radius:8px!important}.v-application .rounded-b-xl{border-bottom-left-radius:24px!important;border-bottom-right-radius:24px!important}.v-application .rounded-b-pill{border-bottom-left-radius:9999px!important;border-bottom-right-radius:9999px!important}.v-application .rounded-b-circle{border-bottom-left-radius:50%!important;border-bottom-right-radius:50%!important}.v-application .rounded-l-0{border-top-left-radius:0!important;border-bottom-left-radius:0!important}.v-application .rounded-l-sm{border-top-left-radius:2px!important;border-bottom-left-radius:2px!important}.v-application .rounded-l{border-top-left-radius:4px!important;border-bottom-left-radius:4px!important}.v-application .rounded-l-lg{border-top-left-radius:8px!important;border-bottom-left-radius:8px!important}.v-application .rounded-l-xl{border-top-left-radius:24px!important;border-bottom-left-radius:24px!important}.v-application .rounded-l-pill{border-top-left-radius:9999px!important;border-bottom-left-radius:9999px!important}.v-application .rounded-l-circle{border-top-left-radius:50%!important;border-bottom-left-radius:50%!important}.v-application .rounded-tl-0{border-top-left-radius:0!important}.v-application .rounded-tl-sm{border-top-left-radius:2px!important}.v-application .rounded-tl{border-top-left-radius:4px!important}.v-application .rounded-tl-lg{border-top-left-radius:8px!important}.v-application .rounded-tl-xl{border-top-left-radius:24px!important}.v-application .rounded-tl-pill{border-top-left-radius:9999px!important}.v-application .rounded-tl-circle{border-top-left-radius:50%!important}.v-application .rounded-tr-0{border-top-right-radius:0!important}.v-application .rounded-tr-sm{border-top-right-radius:2px!important}.v-application .rounded-tr{border-top-right-radius:4px!important}.v-application .rounded-tr-lg{border-top-right-radius:8px!important}.v-application .rounded-tr-xl{border-top-right-radius:24px!important}.v-application .rounded-tr-pill{border-top-right-radius:9999px!important}.v-application .rounded-tr-circle{border-top-right-radius:50%!important}.v-application .rounded-br-0{border-bottom-right-radius:0!important}.v-application .rounded-br-sm{border-bottom-right-radius:2px!important}.v-application .rounded-br{border-bottom-right-radius:4px!important}.v-application .rounded-br-lg{border-bottom-right-radius:8px!important}.v-application .rounded-br-xl{border-bottom-right-radius:24px!important}.v-application .rounded-br-pill{border-bottom-right-radius:9999px!important}.v-application .rounded-br-circle{border-bottom-right-radius:50%!important}.v-application .rounded-bl-0{border-bottom-left-radius:0!important}.v-application .rounded-bl-sm{border-bottom-left-radius:2px!important}.v-application .rounded-bl{border-bottom-left-radius:4px!important}.v-application .rounded-bl-lg{border-bottom-left-radius:8px!important}.v-application .rounded-bl-xl{border-bottom-left-radius:24px!important}.v-application .rounded-bl-pill{border-bottom-left-radius:9999px!important}.v-application .rounded-bl-circle{border-bottom-left-radius:50%!important}.v-application .text-left{text-align:left!important}.v-application .text-right{text-align:right!important}.v-application .text-center{text-align:center!important}.v-application .text-justify{text-align:justify!important}.v-application .text-start{text-align:start!important}.v-application .text-end{text-align:end!important}.v-application .text-decoration-line-through{text-decoration:line-through!important}.v-application .text-decoration-none{text-decoration:none!important}.v-application .text-decoration-overline{text-decoration:overline!important}.v-application .text-decoration-underline{text-decoration:underline!important}.v-application .text-wrap{white-space:normal!important}.v-application .text-no-wrap{white-space:nowrap!important}.v-application .text-pre{white-space:pre!important}.v-application .text-pre-line{white-space:pre-line!important}.v-application .text-pre-wrap{white-space:pre-wrap!important}.v-application .text-break{overflow-wrap:break-word!important;word-break:break-word!important}.v-application .text-truncate{white-space:nowrap!important;overflow:hidden!important;text-overflow:ellipsis!important}.v-application .text-none{text-transform:none!important}.v-application .text-capitalize{text-transform:capitalize!important}.v-application .text-lowercase{text-transform:lowercase!important}.v-application .text-uppercase{text-transform:uppercase!important}.v-application .text-h1{font-size:6rem!important;line-height:6rem;letter-spacing:-.015625em!important}.v-application .text-h1,.v-application .text-h2{font-weight:300;font-family:Roboto,sans-serif!important}.v-application .text-h2{font-size:3.75rem!important;line-height:3.75rem;letter-spacing:-.0083333333em!important}.v-application .text-h3{font-size:3rem!important;line-height:3.125rem;letter-spacing:normal!important}.v-application .text-h3,.v-application .text-h4{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .text-h4{font-size:2.125rem!important;line-height:2.5rem;letter-spacing:.0073529412em!important}.v-application .text-h5{font-size:1.5rem!important;font-weight:400;letter-spacing:normal!important}.v-application .text-h5,.v-application .text-h6{line-height:2rem;font-family:Roboto,sans-serif!important}.v-application .text-h6{font-size:1.25rem!important;font-weight:500;letter-spacing:.0125em!important}.v-application .text-subtitle-1{font-size:1rem!important;font-weight:400;line-height:1.75rem;letter-spacing:.009375em!important;font-family:Roboto,sans-serif!important}.v-application .text-subtitle-2{font-size:.875rem!important;font-weight:500;line-height:1.375rem;letter-spacing:.0071428571em!important;font-family:Roboto,sans-serif!important}.v-application .text-body-1{font-size:1rem!important;font-weight:400;line-height:1.5rem;letter-spacing:.03125em!important;font-family:Roboto,sans-serif!important}.v-application .text-body-2{font-weight:400;line-height:1.25rem;letter-spacing:.0178571429em!important}.v-application .text-body-2,.v-application .text-button{font-size:.875rem!important;font-family:Roboto,sans-serif!important}.v-application .text-button{font-weight:500;line-height:2.25rem;letter-spacing:.0892857143em!important;text-transform:uppercase!important}.v-application .text-caption{font-weight:400;line-height:1.25rem;letter-spacing:.0333333333em!important}.v-application .text-caption,.v-application .text-overline{font-size:.75rem!important;font-family:Roboto,sans-serif!important}.v-application .text-overline{font-weight:500;line-height:2rem;letter-spacing:.1666666667em!important;text-transform:uppercase!important}@media(min-width:600px){.v-application .d-sm-none{display:none!important}.v-application .d-sm-inline{display:inline!important}.v-application .d-sm-inline-block{display:inline-block!important}.v-application .d-sm-block{display:block!important}.v-application .d-sm-table{display:table!important}.v-application .d-sm-table-row{display:table-row!important}.v-application .d-sm-table-cell{display:table-cell!important}.v-application .d-sm-flex{display:flex!important}.v-application .d-sm-inline-flex{display:inline-flex!important}.v-application .float-sm-none{float:none!important}.v-application .float-sm-left{float:left!important}.v-application .float-sm-right{float:right!important}.v-application--is-rtl .float-sm-end{float:left!important}.v-application--is-ltr .float-sm-end,.v-application--is-rtl .float-sm-start{float:right!important}.v-application--is-ltr .float-sm-start{float:left!important}.v-application .flex-sm-fill{flex:1 1 auto!important}.v-application .flex-sm-row{flex-direction:row!important}.v-application .flex-sm-column{flex-direction:column!important}.v-application .flex-sm-row-reverse{flex-direction:row-reverse!important}.v-application .flex-sm-column-reverse{flex-direction:column-reverse!important}.v-application .flex-sm-grow-0{flex-grow:0!important}.v-application .flex-sm-grow-1{flex-grow:1!important}.v-application .flex-sm-shrink-0{flex-shrink:0!important}.v-application .flex-sm-shrink-1{flex-shrink:1!important}.v-application .flex-sm-wrap{flex-wrap:wrap!important}.v-application .flex-sm-nowrap{flex-wrap:nowrap!important}.v-application .flex-sm-wrap-reverse{flex-wrap:wrap-reverse!important}.v-application .justify-sm-start{justify-content:flex-start!important}.v-application .justify-sm-end{justify-content:flex-end!important}.v-application .justify-sm-center{justify-content:center!important}.v-application .justify-sm-space-between{justify-content:space-between!important}.v-application .justify-sm-space-around{justify-content:space-around!important}.v-application .align-sm-start{align-items:flex-start!important}.v-application .align-sm-end{align-items:flex-end!important}.v-application .align-sm-center{align-items:center!important}.v-application .align-sm-baseline{align-items:baseline!important}.v-application .align-sm-stretch{align-items:stretch!important}.v-application .align-content-sm-start{align-content:flex-start!important}.v-application .align-content-sm-end{align-content:flex-end!important}.v-application .align-content-sm-center{align-content:center!important}.v-application .align-content-sm-space-between{align-content:space-between!important}.v-application .align-content-sm-space-around{align-content:space-around!important}.v-application .align-content-sm-stretch{align-content:stretch!important}.v-application .align-self-sm-auto{align-self:auto!important}.v-application .align-self-sm-start{align-self:flex-start!important}.v-application .align-self-sm-end{align-self:flex-end!important}.v-application .align-self-sm-center{align-self:center!important}.v-application .align-self-sm-baseline{align-self:baseline!important}.v-application .align-self-sm-stretch{align-self:stretch!important}.v-application .order-sm-first{order:-1!important}.v-application .order-sm-0{order:0!important}.v-application .order-sm-1{order:1!important}.v-application .order-sm-2{order:2!important}.v-application .order-sm-3{order:3!important}.v-application .order-sm-4{order:4!important}.v-application .order-sm-5{order:5!important}.v-application .order-sm-6{order:6!important}.v-application .order-sm-7{order:7!important}.v-application .order-sm-8{order:8!important}.v-application .order-sm-9{order:9!important}.v-application .order-sm-10{order:10!important}.v-application .order-sm-11{order:11!important}.v-application .order-sm-12{order:12!important}.v-application .order-sm-last{order:13!important}.v-application .ma-sm-0{margin:0!important}.v-application .ma-sm-1{margin:4px!important}.v-application .ma-sm-2{margin:8px!important}.v-application .ma-sm-3{margin:12px!important}.v-application .ma-sm-4{margin:16px!important}.v-application .ma-sm-5{margin:20px!important}.v-application .ma-sm-6{margin:24px!important}.v-application .ma-sm-7{margin:28px!important}.v-application .ma-sm-8{margin:32px!important}.v-application .ma-sm-9{margin:36px!important}.v-application .ma-sm-10{margin:40px!important}.v-application .ma-sm-11{margin:44px!important}.v-application .ma-sm-12{margin:48px!important}.v-application .ma-sm-13{margin:52px!important}.v-application .ma-sm-14{margin:56px!important}.v-application .ma-sm-15{margin:60px!important}.v-application .ma-sm-16{margin:64px!important}.v-application .ma-sm-auto{margin:auto!important}.v-application .mx-sm-0{margin-right:0!important;margin-left:0!important}.v-application .mx-sm-1{margin-right:4px!important;margin-left:4px!important}.v-application .mx-sm-2{margin-right:8px!important;margin-left:8px!important}.v-application .mx-sm-3{margin-right:12px!important;margin-left:12px!important}.v-application .mx-sm-4{margin-right:16px!important;margin-left:16px!important}.v-application .mx-sm-5{margin-right:20px!important;margin-left:20px!important}.v-application .mx-sm-6{margin-right:24px!important;margin-left:24px!important}.v-application .mx-sm-7{margin-right:28px!important;margin-left:28px!important}.v-application .mx-sm-8{margin-right:32px!important;margin-left:32px!important}.v-application .mx-sm-9{margin-right:36px!important;margin-left:36px!important}.v-application .mx-sm-10{margin-right:40px!important;margin-left:40px!important}.v-application .mx-sm-11{margin-right:44px!important;margin-left:44px!important}.v-application .mx-sm-12{margin-right:48px!important;margin-left:48px!important}.v-application .mx-sm-13{margin-right:52px!important;margin-left:52px!important}.v-application .mx-sm-14{margin-right:56px!important;margin-left:56px!important}.v-application .mx-sm-15{margin-right:60px!important;margin-left:60px!important}.v-application .mx-sm-16{margin-right:64px!important;margin-left:64px!important}.v-application .mx-sm-auto{margin-right:auto!important;margin-left:auto!important}.v-application .my-sm-0{margin-top:0!important;margin-bottom:0!important}.v-application .my-sm-1{margin-top:4px!important;margin-bottom:4px!important}.v-application .my-sm-2{margin-top:8px!important;margin-bottom:8px!important}.v-application .my-sm-3{margin-top:12px!important;margin-bottom:12px!important}.v-application .my-sm-4{margin-top:16px!important;margin-bottom:16px!important}.v-application .my-sm-5{margin-top:20px!important;margin-bottom:20px!important}.v-application .my-sm-6{margin-top:24px!important;margin-bottom:24px!important}.v-application .my-sm-7{margin-top:28px!important;margin-bottom:28px!important}.v-application .my-sm-8{margin-top:32px!important;margin-bottom:32px!important}.v-application .my-sm-9{margin-top:36px!important;margin-bottom:36px!important}.v-application .my-sm-10{margin-top:40px!important;margin-bottom:40px!important}.v-application .my-sm-11{margin-top:44px!important;margin-bottom:44px!important}.v-application .my-sm-12{margin-top:48px!important;margin-bottom:48px!important}.v-application .my-sm-13{margin-top:52px!important;margin-bottom:52px!important}.v-application .my-sm-14{margin-top:56px!important;margin-bottom:56px!important}.v-application .my-sm-15{margin-top:60px!important;margin-bottom:60px!important}.v-application .my-sm-16{margin-top:64px!important;margin-bottom:64px!important}.v-application .my-sm-auto{margin-top:auto!important;margin-bottom:auto!important}.v-application .mt-sm-0{margin-top:0!important}.v-application .mt-sm-1{margin-top:4px!important}.v-application .mt-sm-2{margin-top:8px!important}.v-application .mt-sm-3{margin-top:12px!important}.v-application .mt-sm-4{margin-top:16px!important}.v-application .mt-sm-5{margin-top:20px!important}.v-application .mt-sm-6{margin-top:24px!important}.v-application .mt-sm-7{margin-top:28px!important}.v-application .mt-sm-8{margin-top:32px!important}.v-application .mt-sm-9{margin-top:36px!important}.v-application .mt-sm-10{margin-top:40px!important}.v-application .mt-sm-11{margin-top:44px!important}.v-application .mt-sm-12{margin-top:48px!important}.v-application .mt-sm-13{margin-top:52px!important}.v-application .mt-sm-14{margin-top:56px!important}.v-application .mt-sm-15{margin-top:60px!important}.v-application .mt-sm-16{margin-top:64px!important}.v-application .mt-sm-auto{margin-top:auto!important}.v-application .mr-sm-0{margin-right:0!important}.v-application .mr-sm-1{margin-right:4px!important}.v-application .mr-sm-2{margin-right:8px!important}.v-application .mr-sm-3{margin-right:12px!important}.v-application .mr-sm-4{margin-right:16px!important}.v-application .mr-sm-5{margin-right:20px!important}.v-application .mr-sm-6{margin-right:24px!important}.v-application .mr-sm-7{margin-right:28px!important}.v-application .mr-sm-8{margin-right:32px!important}.v-application .mr-sm-9{margin-right:36px!important}.v-application .mr-sm-10{margin-right:40px!important}.v-application .mr-sm-11{margin-right:44px!important}.v-application .mr-sm-12{margin-right:48px!important}.v-application .mr-sm-13{margin-right:52px!important}.v-application .mr-sm-14{margin-right:56px!important}.v-application .mr-sm-15{margin-right:60px!important}.v-application .mr-sm-16{margin-right:64px!important}.v-application .mr-sm-auto{margin-right:auto!important}.v-application .mb-sm-0{margin-bottom:0!important}.v-application .mb-sm-1{margin-bottom:4px!important}.v-application .mb-sm-2{margin-bottom:8px!important}.v-application .mb-sm-3{margin-bottom:12px!important}.v-application .mb-sm-4{margin-bottom:16px!important}.v-application .mb-sm-5{margin-bottom:20px!important}.v-application .mb-sm-6{margin-bottom:24px!important}.v-application .mb-sm-7{margin-bottom:28px!important}.v-application .mb-sm-8{margin-bottom:32px!important}.v-application .mb-sm-9{margin-bottom:36px!important}.v-application .mb-sm-10{margin-bottom:40px!important}.v-application .mb-sm-11{margin-bottom:44px!important}.v-application .mb-sm-12{margin-bottom:48px!important}.v-application .mb-sm-13{margin-bottom:52px!important}.v-application .mb-sm-14{margin-bottom:56px!important}.v-application .mb-sm-15{margin-bottom:60px!important}.v-application .mb-sm-16{margin-bottom:64px!important}.v-application .mb-sm-auto{margin-bottom:auto!important}.v-application .ml-sm-0{margin-left:0!important}.v-application .ml-sm-1{margin-left:4px!important}.v-application .ml-sm-2{margin-left:8px!important}.v-application .ml-sm-3{margin-left:12px!important}.v-application .ml-sm-4{margin-left:16px!important}.v-application .ml-sm-5{margin-left:20px!important}.v-application .ml-sm-6{margin-left:24px!important}.v-application .ml-sm-7{margin-left:28px!important}.v-application .ml-sm-8{margin-left:32px!important}.v-application .ml-sm-9{margin-left:36px!important}.v-application .ml-sm-10{margin-left:40px!important}.v-application .ml-sm-11{margin-left:44px!important}.v-application .ml-sm-12{margin-left:48px!important}.v-application .ml-sm-13{margin-left:52px!important}.v-application .ml-sm-14{margin-left:56px!important}.v-application .ml-sm-15{margin-left:60px!important}.v-application .ml-sm-16{margin-left:64px!important}.v-application .ml-sm-auto{margin-left:auto!important}.v-application--is-ltr .ms-sm-0{margin-left:0!important}.v-application--is-rtl .ms-sm-0{margin-right:0!important}.v-application--is-ltr .ms-sm-1{margin-left:4px!important}.v-application--is-rtl .ms-sm-1{margin-right:4px!important}.v-application--is-ltr .ms-sm-2{margin-left:8px!important}.v-application--is-rtl .ms-sm-2{margin-right:8px!important}.v-application--is-ltr .ms-sm-3{margin-left:12px!important}.v-application--is-rtl .ms-sm-3{margin-right:12px!important}.v-application--is-ltr .ms-sm-4{margin-left:16px!important}.v-application--is-rtl .ms-sm-4{margin-right:16px!important}.v-application--is-ltr .ms-sm-5{margin-left:20px!important}.v-application--is-rtl .ms-sm-5{margin-right:20px!important}.v-application--is-ltr .ms-sm-6{margin-left:24px!important}.v-application--is-rtl .ms-sm-6{margin-right:24px!important}.v-application--is-ltr .ms-sm-7{margin-left:28px!important}.v-application--is-rtl .ms-sm-7{margin-right:28px!important}.v-application--is-ltr .ms-sm-8{margin-left:32px!important}.v-application--is-rtl .ms-sm-8{margin-right:32px!important}.v-application--is-ltr .ms-sm-9{margin-left:36px!important}.v-application--is-rtl .ms-sm-9{margin-right:36px!important}.v-application--is-ltr .ms-sm-10{margin-left:40px!important}.v-application--is-rtl .ms-sm-10{margin-right:40px!important}.v-application--is-ltr .ms-sm-11{margin-left:44px!important}.v-application--is-rtl .ms-sm-11{margin-right:44px!important}.v-application--is-ltr .ms-sm-12{margin-left:48px!important}.v-application--is-rtl .ms-sm-12{margin-right:48px!important}.v-application--is-ltr .ms-sm-13{margin-left:52px!important}.v-application--is-rtl .ms-sm-13{margin-right:52px!important}.v-application--is-ltr .ms-sm-14{margin-left:56px!important}.v-application--is-rtl .ms-sm-14{margin-right:56px!important}.v-application--is-ltr .ms-sm-15{margin-left:60px!important}.v-application--is-rtl .ms-sm-15{margin-right:60px!important}.v-application--is-ltr .ms-sm-16{margin-left:64px!important}.v-application--is-rtl .ms-sm-16{margin-right:64px!important}.v-application--is-ltr .ms-sm-auto{margin-left:auto!important}.v-application--is-rtl .ms-sm-auto{margin-right:auto!important}.v-application--is-ltr .me-sm-0{margin-right:0!important}.v-application--is-rtl .me-sm-0{margin-left:0!important}.v-application--is-ltr .me-sm-1{margin-right:4px!important}.v-application--is-rtl .me-sm-1{margin-left:4px!important}.v-application--is-ltr .me-sm-2{margin-right:8px!important}.v-application--is-rtl .me-sm-2{margin-left:8px!important}.v-application--is-ltr .me-sm-3{margin-right:12px!important}.v-application--is-rtl .me-sm-3{margin-left:12px!important}.v-application--is-ltr .me-sm-4{margin-right:16px!important}.v-application--is-rtl .me-sm-4{margin-left:16px!important}.v-application--is-ltr .me-sm-5{margin-right:20px!important}.v-application--is-rtl .me-sm-5{margin-left:20px!important}.v-application--is-ltr .me-sm-6{margin-right:24px!important}.v-application--is-rtl .me-sm-6{margin-left:24px!important}.v-application--is-ltr .me-sm-7{margin-right:28px!important}.v-application--is-rtl .me-sm-7{margin-left:28px!important}.v-application--is-ltr .me-sm-8{margin-right:32px!important}.v-application--is-rtl .me-sm-8{margin-left:32px!important}.v-application--is-ltr .me-sm-9{margin-right:36px!important}.v-application--is-rtl .me-sm-9{margin-left:36px!important}.v-application--is-ltr .me-sm-10{margin-right:40px!important}.v-application--is-rtl .me-sm-10{margin-left:40px!important}.v-application--is-ltr .me-sm-11{margin-right:44px!important}.v-application--is-rtl .me-sm-11{margin-left:44px!important}.v-application--is-ltr .me-sm-12{margin-right:48px!important}.v-application--is-rtl .me-sm-12{margin-left:48px!important}.v-application--is-ltr .me-sm-13{margin-right:52px!important}.v-application--is-rtl .me-sm-13{margin-left:52px!important}.v-application--is-ltr .me-sm-14{margin-right:56px!important}.v-application--is-rtl .me-sm-14{margin-left:56px!important}.v-application--is-ltr .me-sm-15{margin-right:60px!important}.v-application--is-rtl .me-sm-15{margin-left:60px!important}.v-application--is-ltr .me-sm-16{margin-right:64px!important}.v-application--is-rtl .me-sm-16{margin-left:64px!important}.v-application--is-ltr .me-sm-auto{margin-right:auto!important}.v-application--is-rtl .me-sm-auto{margin-left:auto!important}.v-application .ma-sm-n1{margin:-4px!important}.v-application .ma-sm-n2{margin:-8px!important}.v-application .ma-sm-n3{margin:-12px!important}.v-application .ma-sm-n4{margin:-16px!important}.v-application .ma-sm-n5{margin:-20px!important}.v-application .ma-sm-n6{margin:-24px!important}.v-application .ma-sm-n7{margin:-28px!important}.v-application .ma-sm-n8{margin:-32px!important}.v-application .ma-sm-n9{margin:-36px!important}.v-application .ma-sm-n10{margin:-40px!important}.v-application .ma-sm-n11{margin:-44px!important}.v-application .ma-sm-n12{margin:-48px!important}.v-application .ma-sm-n13{margin:-52px!important}.v-application .ma-sm-n14{margin:-56px!important}.v-application .ma-sm-n15{margin:-60px!important}.v-application .ma-sm-n16{margin:-64px!important}.v-application .mx-sm-n1{margin-right:-4px!important;margin-left:-4px!important}.v-application .mx-sm-n2{margin-right:-8px!important;margin-left:-8px!important}.v-application .mx-sm-n3{margin-right:-12px!important;margin-left:-12px!important}.v-application .mx-sm-n4{margin-right:-16px!important;margin-left:-16px!important}.v-application .mx-sm-n5{margin-right:-20px!important;margin-left:-20px!important}.v-application .mx-sm-n6{margin-right:-24px!important;margin-left:-24px!important}.v-application .mx-sm-n7{margin-right:-28px!important;margin-left:-28px!important}.v-application .mx-sm-n8{margin-right:-32px!important;margin-left:-32px!important}.v-application .mx-sm-n9{margin-right:-36px!important;margin-left:-36px!important}.v-application .mx-sm-n10{margin-right:-40px!important;margin-left:-40px!important}.v-application .mx-sm-n11{margin-right:-44px!important;margin-left:-44px!important}.v-application .mx-sm-n12{margin-right:-48px!important;margin-left:-48px!important}.v-application .mx-sm-n13{margin-right:-52px!important;margin-left:-52px!important}.v-application .mx-sm-n14{margin-right:-56px!important;margin-left:-56px!important}.v-application .mx-sm-n15{margin-right:-60px!important;margin-left:-60px!important}.v-application .mx-sm-n16{margin-right:-64px!important;margin-left:-64px!important}.v-application .my-sm-n1{margin-top:-4px!important;margin-bottom:-4px!important}.v-application .my-sm-n2{margin-top:-8px!important;margin-bottom:-8px!important}.v-application .my-sm-n3{margin-top:-12px!important;margin-bottom:-12px!important}.v-application .my-sm-n4{margin-top:-16px!important;margin-bottom:-16px!important}.v-application .my-sm-n5{margin-top:-20px!important;margin-bottom:-20px!important}.v-application .my-sm-n6{margin-top:-24px!important;margin-bottom:-24px!important}.v-application .my-sm-n7{margin-top:-28px!important;margin-bottom:-28px!important}.v-application .my-sm-n8{margin-top:-32px!important;margin-bottom:-32px!important}.v-application .my-sm-n9{margin-top:-36px!important;margin-bottom:-36px!important}.v-application .my-sm-n10{margin-top:-40px!important;margin-bottom:-40px!important}.v-application .my-sm-n11{margin-top:-44px!important;margin-bottom:-44px!important}.v-application .my-sm-n12{margin-top:-48px!important;margin-bottom:-48px!important}.v-application .my-sm-n13{margin-top:-52px!important;margin-bottom:-52px!important}.v-application .my-sm-n14{margin-top:-56px!important;margin-bottom:-56px!important}.v-application .my-sm-n15{margin-top:-60px!important;margin-bottom:-60px!important}.v-application .my-sm-n16{margin-top:-64px!important;margin-bottom:-64px!important}.v-application .mt-sm-n1{margin-top:-4px!important}.v-application .mt-sm-n2{margin-top:-8px!important}.v-application .mt-sm-n3{margin-top:-12px!important}.v-application .mt-sm-n4{margin-top:-16px!important}.v-application .mt-sm-n5{margin-top:-20px!important}.v-application .mt-sm-n6{margin-top:-24px!important}.v-application .mt-sm-n7{margin-top:-28px!important}.v-application .mt-sm-n8{margin-top:-32px!important}.v-application .mt-sm-n9{margin-top:-36px!important}.v-application .mt-sm-n10{margin-top:-40px!important}.v-application .mt-sm-n11{margin-top:-44px!important}.v-application .mt-sm-n12{margin-top:-48px!important}.v-application .mt-sm-n13{margin-top:-52px!important}.v-application .mt-sm-n14{margin-top:-56px!important}.v-application .mt-sm-n15{margin-top:-60px!important}.v-application .mt-sm-n16{margin-top:-64px!important}.v-application .mr-sm-n1{margin-right:-4px!important}.v-application .mr-sm-n2{margin-right:-8px!important}.v-application .mr-sm-n3{margin-right:-12px!important}.v-application .mr-sm-n4{margin-right:-16px!important}.v-application .mr-sm-n5{margin-right:-20px!important}.v-application .mr-sm-n6{margin-right:-24px!important}.v-application .mr-sm-n7{margin-right:-28px!important}.v-application .mr-sm-n8{margin-right:-32px!important}.v-application .mr-sm-n9{margin-right:-36px!important}.v-application .mr-sm-n10{margin-right:-40px!important}.v-application .mr-sm-n11{margin-right:-44px!important}.v-application .mr-sm-n12{margin-right:-48px!important}.v-application .mr-sm-n13{margin-right:-52px!important}.v-application .mr-sm-n14{margin-right:-56px!important}.v-application .mr-sm-n15{margin-right:-60px!important}.v-application .mr-sm-n16{margin-right:-64px!important}.v-application .mb-sm-n1{margin-bottom:-4px!important}.v-application .mb-sm-n2{margin-bottom:-8px!important}.v-application .mb-sm-n3{margin-bottom:-12px!important}.v-application .mb-sm-n4{margin-bottom:-16px!important}.v-application .mb-sm-n5{margin-bottom:-20px!important}.v-application .mb-sm-n6{margin-bottom:-24px!important}.v-application .mb-sm-n7{margin-bottom:-28px!important}.v-application .mb-sm-n8{margin-bottom:-32px!important}.v-application .mb-sm-n9{margin-bottom:-36px!important}.v-application .mb-sm-n10{margin-bottom:-40px!important}.v-application .mb-sm-n11{margin-bottom:-44px!important}.v-application .mb-sm-n12{margin-bottom:-48px!important}.v-application .mb-sm-n13{margin-bottom:-52px!important}.v-application .mb-sm-n14{margin-bottom:-56px!important}.v-application .mb-sm-n15{margin-bottom:-60px!important}.v-application .mb-sm-n16{margin-bottom:-64px!important}.v-application .ml-sm-n1{margin-left:-4px!important}.v-application .ml-sm-n2{margin-left:-8px!important}.v-application .ml-sm-n3{margin-left:-12px!important}.v-application .ml-sm-n4{margin-left:-16px!important}.v-application .ml-sm-n5{margin-left:-20px!important}.v-application .ml-sm-n6{margin-left:-24px!important}.v-application .ml-sm-n7{margin-left:-28px!important}.v-application .ml-sm-n8{margin-left:-32px!important}.v-application .ml-sm-n9{margin-left:-36px!important}.v-application .ml-sm-n10{margin-left:-40px!important}.v-application .ml-sm-n11{margin-left:-44px!important}.v-application .ml-sm-n12{margin-left:-48px!important}.v-application .ml-sm-n13{margin-left:-52px!important}.v-application .ml-sm-n14{margin-left:-56px!important}.v-application .ml-sm-n15{margin-left:-60px!important}.v-application .ml-sm-n16{margin-left:-64px!important}.v-application--is-ltr .ms-sm-n1{margin-left:-4px!important}.v-application--is-rtl .ms-sm-n1{margin-right:-4px!important}.v-application--is-ltr .ms-sm-n2{margin-left:-8px!important}.v-application--is-rtl .ms-sm-n2{margin-right:-8px!important}.v-application--is-ltr .ms-sm-n3{margin-left:-12px!important}.v-application--is-rtl .ms-sm-n3{margin-right:-12px!important}.v-application--is-ltr .ms-sm-n4{margin-left:-16px!important}.v-application--is-rtl .ms-sm-n4{margin-right:-16px!important}.v-application--is-ltr .ms-sm-n5{margin-left:-20px!important}.v-application--is-rtl .ms-sm-n5{margin-right:-20px!important}.v-application--is-ltr .ms-sm-n6{margin-left:-24px!important}.v-application--is-rtl .ms-sm-n6{margin-right:-24px!important}.v-application--is-ltr .ms-sm-n7{margin-left:-28px!important}.v-application--is-rtl .ms-sm-n7{margin-right:-28px!important}.v-application--is-ltr .ms-sm-n8{margin-left:-32px!important}.v-application--is-rtl .ms-sm-n8{margin-right:-32px!important}.v-application--is-ltr .ms-sm-n9{margin-left:-36px!important}.v-application--is-rtl .ms-sm-n9{margin-right:-36px!important}.v-application--is-ltr .ms-sm-n10{margin-left:-40px!important}.v-application--is-rtl .ms-sm-n10{margin-right:-40px!important}.v-application--is-ltr .ms-sm-n11{margin-left:-44px!important}.v-application--is-rtl .ms-sm-n11{margin-right:-44px!important}.v-application--is-ltr .ms-sm-n12{margin-left:-48px!important}.v-application--is-rtl .ms-sm-n12{margin-right:-48px!important}.v-application--is-ltr .ms-sm-n13{margin-left:-52px!important}.v-application--is-rtl .ms-sm-n13{margin-right:-52px!important}.v-application--is-ltr .ms-sm-n14{margin-left:-56px!important}.v-application--is-rtl .ms-sm-n14{margin-right:-56px!important}.v-application--is-ltr .ms-sm-n15{margin-left:-60px!important}.v-application--is-rtl .ms-sm-n15{margin-right:-60px!important}.v-application--is-ltr .ms-sm-n16{margin-left:-64px!important}.v-application--is-rtl .ms-sm-n16{margin-right:-64px!important}.v-application--is-ltr .me-sm-n1{margin-right:-4px!important}.v-application--is-rtl .me-sm-n1{margin-left:-4px!important}.v-application--is-ltr .me-sm-n2{margin-right:-8px!important}.v-application--is-rtl .me-sm-n2{margin-left:-8px!important}.v-application--is-ltr .me-sm-n3{margin-right:-12px!important}.v-application--is-rtl .me-sm-n3{margin-left:-12px!important}.v-application--is-ltr .me-sm-n4{margin-right:-16px!important}.v-application--is-rtl .me-sm-n4{margin-left:-16px!important}.v-application--is-ltr .me-sm-n5{margin-right:-20px!important}.v-application--is-rtl .me-sm-n5{margin-left:-20px!important}.v-application--is-ltr .me-sm-n6{margin-right:-24px!important}.v-application--is-rtl .me-sm-n6{margin-left:-24px!important}.v-application--is-ltr .me-sm-n7{margin-right:-28px!important}.v-application--is-rtl .me-sm-n7{margin-left:-28px!important}.v-application--is-ltr .me-sm-n8{margin-right:-32px!important}.v-application--is-rtl .me-sm-n8{margin-left:-32px!important}.v-application--is-ltr .me-sm-n9{margin-right:-36px!important}.v-application--is-rtl .me-sm-n9{margin-left:-36px!important}.v-application--is-ltr .me-sm-n10{margin-right:-40px!important}.v-application--is-rtl .me-sm-n10{margin-left:-40px!important}.v-application--is-ltr .me-sm-n11{margin-right:-44px!important}.v-application--is-rtl .me-sm-n11{margin-left:-44px!important}.v-application--is-ltr .me-sm-n12{margin-right:-48px!important}.v-application--is-rtl .me-sm-n12{margin-left:-48px!important}.v-application--is-ltr .me-sm-n13{margin-right:-52px!important}.v-application--is-rtl .me-sm-n13{margin-left:-52px!important}.v-application--is-ltr .me-sm-n14{margin-right:-56px!important}.v-application--is-rtl .me-sm-n14{margin-left:-56px!important}.v-application--is-ltr .me-sm-n15{margin-right:-60px!important}.v-application--is-rtl .me-sm-n15{margin-left:-60px!important}.v-application--is-ltr .me-sm-n16{margin-right:-64px!important}.v-application--is-rtl .me-sm-n16{margin-left:-64px!important}.v-application .pa-sm-0{padding:0!important}.v-application .pa-sm-1{padding:4px!important}.v-application .pa-sm-2{padding:8px!important}.v-application .pa-sm-3{padding:12px!important}.v-application .pa-sm-4{padding:16px!important}.v-application .pa-sm-5{padding:20px!important}.v-application .pa-sm-6{padding:24px!important}.v-application .pa-sm-7{padding:28px!important}.v-application .pa-sm-8{padding:32px!important}.v-application .pa-sm-9{padding:36px!important}.v-application .pa-sm-10{padding:40px!important}.v-application .pa-sm-11{padding:44px!important}.v-application .pa-sm-12{padding:48px!important}.v-application .pa-sm-13{padding:52px!important}.v-application .pa-sm-14{padding:56px!important}.v-application .pa-sm-15{padding:60px!important}.v-application .pa-sm-16{padding:64px!important}.v-application .px-sm-0{padding-right:0!important;padding-left:0!important}.v-application .px-sm-1{padding-right:4px!important;padding-left:4px!important}.v-application .px-sm-2{padding-right:8px!important;padding-left:8px!important}.v-application .px-sm-3{padding-right:12px!important;padding-left:12px!important}.v-application .px-sm-4{padding-right:16px!important;padding-left:16px!important}.v-application .px-sm-5{padding-right:20px!important;padding-left:20px!important}.v-application .px-sm-6{padding-right:24px!important;padding-left:24px!important}.v-application .px-sm-7{padding-right:28px!important;padding-left:28px!important}.v-application .px-sm-8{padding-right:32px!important;padding-left:32px!important}.v-application .px-sm-9{padding-right:36px!important;padding-left:36px!important}.v-application .px-sm-10{padding-right:40px!important;padding-left:40px!important}.v-application .px-sm-11{padding-right:44px!important;padding-left:44px!important}.v-application .px-sm-12{padding-right:48px!important;padding-left:48px!important}.v-application .px-sm-13{padding-right:52px!important;padding-left:52px!important}.v-application .px-sm-14{padding-right:56px!important;padding-left:56px!important}.v-application .px-sm-15{padding-right:60px!important;padding-left:60px!important}.v-application .px-sm-16{padding-right:64px!important;padding-left:64px!important}.v-application .py-sm-0{padding-top:0!important;padding-bottom:0!important}.v-application .py-sm-1{padding-top:4px!important;padding-bottom:4px!important}.v-application .py-sm-2{padding-top:8px!important;padding-bottom:8px!important}.v-application .py-sm-3{padding-top:12px!important;padding-bottom:12px!important}.v-application .py-sm-4{padding-top:16px!important;padding-bottom:16px!important}.v-application .py-sm-5{padding-top:20px!important;padding-bottom:20px!important}.v-application .py-sm-6{padding-top:24px!important;padding-bottom:24px!important}.v-application .py-sm-7{padding-top:28px!important;padding-bottom:28px!important}.v-application .py-sm-8{padding-top:32px!important;padding-bottom:32px!important}.v-application .py-sm-9{padding-top:36px!important;padding-bottom:36px!important}.v-application .py-sm-10{padding-top:40px!important;padding-bottom:40px!important}.v-application .py-sm-11{padding-top:44px!important;padding-bottom:44px!important}.v-application .py-sm-12{padding-top:48px!important;padding-bottom:48px!important}.v-application .py-sm-13{padding-top:52px!important;padding-bottom:52px!important}.v-application .py-sm-14{padding-top:56px!important;padding-bottom:56px!important}.v-application .py-sm-15{padding-top:60px!important;padding-bottom:60px!important}.v-application .py-sm-16{padding-top:64px!important;padding-bottom:64px!important}.v-application .pt-sm-0{padding-top:0!important}.v-application .pt-sm-1{padding-top:4px!important}.v-application .pt-sm-2{padding-top:8px!important}.v-application .pt-sm-3{padding-top:12px!important}.v-application .pt-sm-4{padding-top:16px!important}.v-application .pt-sm-5{padding-top:20px!important}.v-application .pt-sm-6{padding-top:24px!important}.v-application .pt-sm-7{padding-top:28px!important}.v-application .pt-sm-8{padding-top:32px!important}.v-application .pt-sm-9{padding-top:36px!important}.v-application .pt-sm-10{padding-top:40px!important}.v-application .pt-sm-11{padding-top:44px!important}.v-application .pt-sm-12{padding-top:48px!important}.v-application .pt-sm-13{padding-top:52px!important}.v-application .pt-sm-14{padding-top:56px!important}.v-application .pt-sm-15{padding-top:60px!important}.v-application .pt-sm-16{padding-top:64px!important}.v-application .pr-sm-0{padding-right:0!important}.v-application .pr-sm-1{padding-right:4px!important}.v-application .pr-sm-2{padding-right:8px!important}.v-application .pr-sm-3{padding-right:12px!important}.v-application .pr-sm-4{padding-right:16px!important}.v-application .pr-sm-5{padding-right:20px!important}.v-application .pr-sm-6{padding-right:24px!important}.v-application .pr-sm-7{padding-right:28px!important}.v-application .pr-sm-8{padding-right:32px!important}.v-application .pr-sm-9{padding-right:36px!important}.v-application .pr-sm-10{padding-right:40px!important}.v-application .pr-sm-11{padding-right:44px!important}.v-application .pr-sm-12{padding-right:48px!important}.v-application .pr-sm-13{padding-right:52px!important}.v-application .pr-sm-14{padding-right:56px!important}.v-application .pr-sm-15{padding-right:60px!important}.v-application .pr-sm-16{padding-right:64px!important}.v-application .pb-sm-0{padding-bottom:0!important}.v-application .pb-sm-1{padding-bottom:4px!important}.v-application .pb-sm-2{padding-bottom:8px!important}.v-application .pb-sm-3{padding-bottom:12px!important}.v-application .pb-sm-4{padding-bottom:16px!important}.v-application .pb-sm-5{padding-bottom:20px!important}.v-application .pb-sm-6{padding-bottom:24px!important}.v-application .pb-sm-7{padding-bottom:28px!important}.v-application .pb-sm-8{padding-bottom:32px!important}.v-application .pb-sm-9{padding-bottom:36px!important}.v-application .pb-sm-10{padding-bottom:40px!important}.v-application .pb-sm-11{padding-bottom:44px!important}.v-application .pb-sm-12{padding-bottom:48px!important}.v-application .pb-sm-13{padding-bottom:52px!important}.v-application .pb-sm-14{padding-bottom:56px!important}.v-application .pb-sm-15{padding-bottom:60px!important}.v-application .pb-sm-16{padding-bottom:64px!important}.v-application .pl-sm-0{padding-left:0!important}.v-application .pl-sm-1{padding-left:4px!important}.v-application .pl-sm-2{padding-left:8px!important}.v-application .pl-sm-3{padding-left:12px!important}.v-application .pl-sm-4{padding-left:16px!important}.v-application .pl-sm-5{padding-left:20px!important}.v-application .pl-sm-6{padding-left:24px!important}.v-application .pl-sm-7{padding-left:28px!important}.v-application .pl-sm-8{padding-left:32px!important}.v-application .pl-sm-9{padding-left:36px!important}.v-application .pl-sm-10{padding-left:40px!important}.v-application .pl-sm-11{padding-left:44px!important}.v-application .pl-sm-12{padding-left:48px!important}.v-application .pl-sm-13{padding-left:52px!important}.v-application .pl-sm-14{padding-left:56px!important}.v-application .pl-sm-15{padding-left:60px!important}.v-application .pl-sm-16{padding-left:64px!important}.v-application--is-ltr .ps-sm-0{padding-left:0!important}.v-application--is-rtl .ps-sm-0{padding-right:0!important}.v-application--is-ltr .ps-sm-1{padding-left:4px!important}.v-application--is-rtl .ps-sm-1{padding-right:4px!important}.v-application--is-ltr .ps-sm-2{padding-left:8px!important}.v-application--is-rtl .ps-sm-2{padding-right:8px!important}.v-application--is-ltr .ps-sm-3{padding-left:12px!important}.v-application--is-rtl .ps-sm-3{padding-right:12px!important}.v-application--is-ltr .ps-sm-4{padding-left:16px!important}.v-application--is-rtl .ps-sm-4{padding-right:16px!important}.v-application--is-ltr .ps-sm-5{padding-left:20px!important}.v-application--is-rtl .ps-sm-5{padding-right:20px!important}.v-application--is-ltr .ps-sm-6{padding-left:24px!important}.v-application--is-rtl .ps-sm-6{padding-right:24px!important}.v-application--is-ltr .ps-sm-7{padding-left:28px!important}.v-application--is-rtl .ps-sm-7{padding-right:28px!important}.v-application--is-ltr .ps-sm-8{padding-left:32px!important}.v-application--is-rtl .ps-sm-8{padding-right:32px!important}.v-application--is-ltr .ps-sm-9{padding-left:36px!important}.v-application--is-rtl .ps-sm-9{padding-right:36px!important}.v-application--is-ltr .ps-sm-10{padding-left:40px!important}.v-application--is-rtl .ps-sm-10{padding-right:40px!important}.v-application--is-ltr .ps-sm-11{padding-left:44px!important}.v-application--is-rtl .ps-sm-11{padding-right:44px!important}.v-application--is-ltr .ps-sm-12{padding-left:48px!important}.v-application--is-rtl .ps-sm-12{padding-right:48px!important}.v-application--is-ltr .ps-sm-13{padding-left:52px!important}.v-application--is-rtl .ps-sm-13{padding-right:52px!important}.v-application--is-ltr .ps-sm-14{padding-left:56px!important}.v-application--is-rtl .ps-sm-14{padding-right:56px!important}.v-application--is-ltr .ps-sm-15{padding-left:60px!important}.v-application--is-rtl .ps-sm-15{padding-right:60px!important}.v-application--is-ltr .ps-sm-16{padding-left:64px!important}.v-application--is-rtl .ps-sm-16{padding-right:64px!important}.v-application--is-ltr .pe-sm-0{padding-right:0!important}.v-application--is-rtl .pe-sm-0{padding-left:0!important}.v-application--is-ltr .pe-sm-1{padding-right:4px!important}.v-application--is-rtl .pe-sm-1{padding-left:4px!important}.v-application--is-ltr .pe-sm-2{padding-right:8px!important}.v-application--is-rtl .pe-sm-2{padding-left:8px!important}.v-application--is-ltr .pe-sm-3{padding-right:12px!important}.v-application--is-rtl .pe-sm-3{padding-left:12px!important}.v-application--is-ltr .pe-sm-4{padding-right:16px!important}.v-application--is-rtl .pe-sm-4{padding-left:16px!important}.v-application--is-ltr .pe-sm-5{padding-right:20px!important}.v-application--is-rtl .pe-sm-5{padding-left:20px!important}.v-application--is-ltr .pe-sm-6{padding-right:24px!important}.v-application--is-rtl .pe-sm-6{padding-left:24px!important}.v-application--is-ltr .pe-sm-7{padding-right:28px!important}.v-application--is-rtl .pe-sm-7{padding-left:28px!important}.v-application--is-ltr .pe-sm-8{padding-right:32px!important}.v-application--is-rtl .pe-sm-8{padding-left:32px!important}.v-application--is-ltr .pe-sm-9{padding-right:36px!important}.v-application--is-rtl .pe-sm-9{padding-left:36px!important}.v-application--is-ltr .pe-sm-10{padding-right:40px!important}.v-application--is-rtl .pe-sm-10{padding-left:40px!important}.v-application--is-ltr .pe-sm-11{padding-right:44px!important}.v-application--is-rtl .pe-sm-11{padding-left:44px!important}.v-application--is-ltr .pe-sm-12{padding-right:48px!important}.v-application--is-rtl .pe-sm-12{padding-left:48px!important}.v-application--is-ltr .pe-sm-13{padding-right:52px!important}.v-application--is-rtl .pe-sm-13{padding-left:52px!important}.v-application--is-ltr .pe-sm-14{padding-right:56px!important}.v-application--is-rtl .pe-sm-14{padding-left:56px!important}.v-application--is-ltr .pe-sm-15{padding-right:60px!important}.v-application--is-rtl .pe-sm-15{padding-left:60px!important}.v-application--is-ltr .pe-sm-16{padding-right:64px!important}.v-application--is-rtl .pe-sm-16{padding-left:64px!important}.v-application .text-sm-left{text-align:left!important}.v-application .text-sm-right{text-align:right!important}.v-application .text-sm-center{text-align:center!important}.v-application .text-sm-justify{text-align:justify!important}.v-application .text-sm-start{text-align:start!important}.v-application .text-sm-end{text-align:end!important}.v-application .text-sm-h1{font-size:6rem!important;line-height:6rem;letter-spacing:-.015625em!important}.v-application .text-sm-h1,.v-application .text-sm-h2{font-weight:300;font-family:Roboto,sans-serif!important}.v-application .text-sm-h2{font-size:3.75rem!important;line-height:3.75rem;letter-spacing:-.0083333333em!important}.v-application .text-sm-h3{font-size:3rem!important;line-height:3.125rem;letter-spacing:normal!important}.v-application .text-sm-h3,.v-application .text-sm-h4{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .text-sm-h4{font-size:2.125rem!important;line-height:2.5rem;letter-spacing:.0073529412em!important}.v-application .text-sm-h5{font-size:1.5rem!important;font-weight:400;letter-spacing:normal!important}.v-application .text-sm-h5,.v-application .text-sm-h6{line-height:2rem;font-family:Roboto,sans-serif!important}.v-application .text-sm-h6{font-size:1.25rem!important;font-weight:500;letter-spacing:.0125em!important}.v-application .text-sm-subtitle-1{font-size:1rem!important;font-weight:400;line-height:1.75rem;letter-spacing:.009375em!important;font-family:Roboto,sans-serif!important}.v-application .text-sm-subtitle-2{font-size:.875rem!important;font-weight:500;line-height:1.375rem;letter-spacing:.0071428571em!important;font-family:Roboto,sans-serif!important}.v-application .text-sm-body-1{font-size:1rem!important;font-weight:400;line-height:1.5rem;letter-spacing:.03125em!important;font-family:Roboto,sans-serif!important}.v-application .text-sm-body-2{font-weight:400;line-height:1.25rem;letter-spacing:.0178571429em!important}.v-application .text-sm-body-2,.v-application .text-sm-button{font-size:.875rem!important;font-family:Roboto,sans-serif!important}.v-application .text-sm-button{font-weight:500;line-height:2.25rem;letter-spacing:.0892857143em!important;text-transform:uppercase!important}.v-application .text-sm-caption{font-weight:400;line-height:1.25rem;letter-spacing:.0333333333em!important}.v-application .text-sm-caption,.v-application .text-sm-overline{font-size:.75rem!important;font-family:Roboto,sans-serif!important}.v-application .text-sm-overline{font-weight:500;line-height:2rem;letter-spacing:.1666666667em!important;text-transform:uppercase!important}}@media(min-width:960px){.v-application .d-md-none{display:none!important}.v-application .d-md-inline{display:inline!important}.v-application .d-md-inline-block{display:inline-block!important}.v-application .d-md-block{display:block!important}.v-application .d-md-table{display:table!important}.v-application .d-md-table-row{display:table-row!important}.v-application .d-md-table-cell{display:table-cell!important}.v-application .d-md-flex{display:flex!important}.v-application .d-md-inline-flex{display:inline-flex!important}.v-application .float-md-none{float:none!important}.v-application .float-md-left{float:left!important}.v-application .float-md-right{float:right!important}.v-application--is-rtl .float-md-end{float:left!important}.v-application--is-ltr .float-md-end,.v-application--is-rtl .float-md-start{float:right!important}.v-application--is-ltr .float-md-start{float:left!important}.v-application .flex-md-fill{flex:1 1 auto!important}.v-application .flex-md-row{flex-direction:row!important}.v-application .flex-md-column{flex-direction:column!important}.v-application .flex-md-row-reverse{flex-direction:row-reverse!important}.v-application .flex-md-column-reverse{flex-direction:column-reverse!important}.v-application .flex-md-grow-0{flex-grow:0!important}.v-application .flex-md-grow-1{flex-grow:1!important}.v-application .flex-md-shrink-0{flex-shrink:0!important}.v-application .flex-md-shrink-1{flex-shrink:1!important}.v-application .flex-md-wrap{flex-wrap:wrap!important}.v-application .flex-md-nowrap{flex-wrap:nowrap!important}.v-application .flex-md-wrap-reverse{flex-wrap:wrap-reverse!important}.v-application .justify-md-start{justify-content:flex-start!important}.v-application .justify-md-end{justify-content:flex-end!important}.v-application .justify-md-center{justify-content:center!important}.v-application .justify-md-space-between{justify-content:space-between!important}.v-application .justify-md-space-around{justify-content:space-around!important}.v-application .align-md-start{align-items:flex-start!important}.v-application .align-md-end{align-items:flex-end!important}.v-application .align-md-center{align-items:center!important}.v-application .align-md-baseline{align-items:baseline!important}.v-application .align-md-stretch{align-items:stretch!important}.v-application .align-content-md-start{align-content:flex-start!important}.v-application .align-content-md-end{align-content:flex-end!important}.v-application .align-content-md-center{align-content:center!important}.v-application .align-content-md-space-between{align-content:space-between!important}.v-application .align-content-md-space-around{align-content:space-around!important}.v-application .align-content-md-stretch{align-content:stretch!important}.v-application .align-self-md-auto{align-self:auto!important}.v-application .align-self-md-start{align-self:flex-start!important}.v-application .align-self-md-end{align-self:flex-end!important}.v-application .align-self-md-center{align-self:center!important}.v-application .align-self-md-baseline{align-self:baseline!important}.v-application .align-self-md-stretch{align-self:stretch!important}.v-application .order-md-first{order:-1!important}.v-application .order-md-0{order:0!important}.v-application .order-md-1{order:1!important}.v-application .order-md-2{order:2!important}.v-application .order-md-3{order:3!important}.v-application .order-md-4{order:4!important}.v-application .order-md-5{order:5!important}.v-application .order-md-6{order:6!important}.v-application .order-md-7{order:7!important}.v-application .order-md-8{order:8!important}.v-application .order-md-9{order:9!important}.v-application .order-md-10{order:10!important}.v-application .order-md-11{order:11!important}.v-application .order-md-12{order:12!important}.v-application .order-md-last{order:13!important}.v-application .ma-md-0{margin:0!important}.v-application .ma-md-1{margin:4px!important}.v-application .ma-md-2{margin:8px!important}.v-application .ma-md-3{margin:12px!important}.v-application .ma-md-4{margin:16px!important}.v-application .ma-md-5{margin:20px!important}.v-application .ma-md-6{margin:24px!important}.v-application .ma-md-7{margin:28px!important}.v-application .ma-md-8{margin:32px!important}.v-application .ma-md-9{margin:36px!important}.v-application .ma-md-10{margin:40px!important}.v-application .ma-md-11{margin:44px!important}.v-application .ma-md-12{margin:48px!important}.v-application .ma-md-13{margin:52px!important}.v-application .ma-md-14{margin:56px!important}.v-application .ma-md-15{margin:60px!important}.v-application .ma-md-16{margin:64px!important}.v-application .ma-md-auto{margin:auto!important}.v-application .mx-md-0{margin-right:0!important;margin-left:0!important}.v-application .mx-md-1{margin-right:4px!important;margin-left:4px!important}.v-application .mx-md-2{margin-right:8px!important;margin-left:8px!important}.v-application .mx-md-3{margin-right:12px!important;margin-left:12px!important}.v-application .mx-md-4{margin-right:16px!important;margin-left:16px!important}.v-application .mx-md-5{margin-right:20px!important;margin-left:20px!important}.v-application .mx-md-6{margin-right:24px!important;margin-left:24px!important}.v-application .mx-md-7{margin-right:28px!important;margin-left:28px!important}.v-application .mx-md-8{margin-right:32px!important;margin-left:32px!important}.v-application .mx-md-9{margin-right:36px!important;margin-left:36px!important}.v-application .mx-md-10{margin-right:40px!important;margin-left:40px!important}.v-application .mx-md-11{margin-right:44px!important;margin-left:44px!important}.v-application .mx-md-12{margin-right:48px!important;margin-left:48px!important}.v-application .mx-md-13{margin-right:52px!important;margin-left:52px!important}.v-application .mx-md-14{margin-right:56px!important;margin-left:56px!important}.v-application .mx-md-15{margin-right:60px!important;margin-left:60px!important}.v-application .mx-md-16{margin-right:64px!important;margin-left:64px!important}.v-application .mx-md-auto{margin-right:auto!important;margin-left:auto!important}.v-application .my-md-0{margin-top:0!important;margin-bottom:0!important}.v-application .my-md-1{margin-top:4px!important;margin-bottom:4px!important}.v-application .my-md-2{margin-top:8px!important;margin-bottom:8px!important}.v-application .my-md-3{margin-top:12px!important;margin-bottom:12px!important}.v-application .my-md-4{margin-top:16px!important;margin-bottom:16px!important}.v-application .my-md-5{margin-top:20px!important;margin-bottom:20px!important}.v-application .my-md-6{margin-top:24px!important;margin-bottom:24px!important}.v-application .my-md-7{margin-top:28px!important;margin-bottom:28px!important}.v-application .my-md-8{margin-top:32px!important;margin-bottom:32px!important}.v-application .my-md-9{margin-top:36px!important;margin-bottom:36px!important}.v-application .my-md-10{margin-top:40px!important;margin-bottom:40px!important}.v-application .my-md-11{margin-top:44px!important;margin-bottom:44px!important}.v-application .my-md-12{margin-top:48px!important;margin-bottom:48px!important}.v-application .my-md-13{margin-top:52px!important;margin-bottom:52px!important}.v-application .my-md-14{margin-top:56px!important;margin-bottom:56px!important}.v-application .my-md-15{margin-top:60px!important;margin-bottom:60px!important}.v-application .my-md-16{margin-top:64px!important;margin-bottom:64px!important}.v-application .my-md-auto{margin-top:auto!important;margin-bottom:auto!important}.v-application .mt-md-0{margin-top:0!important}.v-application .mt-md-1{margin-top:4px!important}.v-application .mt-md-2{margin-top:8px!important}.v-application .mt-md-3{margin-top:12px!important}.v-application .mt-md-4{margin-top:16px!important}.v-application .mt-md-5{margin-top:20px!important}.v-application .mt-md-6{margin-top:24px!important}.v-application .mt-md-7{margin-top:28px!important}.v-application .mt-md-8{margin-top:32px!important}.v-application .mt-md-9{margin-top:36px!important}.v-application .mt-md-10{margin-top:40px!important}.v-application .mt-md-11{margin-top:44px!important}.v-application .mt-md-12{margin-top:48px!important}.v-application .mt-md-13{margin-top:52px!important}.v-application .mt-md-14{margin-top:56px!important}.v-application .mt-md-15{margin-top:60px!important}.v-application .mt-md-16{margin-top:64px!important}.v-application .mt-md-auto{margin-top:auto!important}.v-application .mr-md-0{margin-right:0!important}.v-application .mr-md-1{margin-right:4px!important}.v-application .mr-md-2{margin-right:8px!important}.v-application .mr-md-3{margin-right:12px!important}.v-application .mr-md-4{margin-right:16px!important}.v-application .mr-md-5{margin-right:20px!important}.v-application .mr-md-6{margin-right:24px!important}.v-application .mr-md-7{margin-right:28px!important}.v-application .mr-md-8{margin-right:32px!important}.v-application .mr-md-9{margin-right:36px!important}.v-application .mr-md-10{margin-right:40px!important}.v-application .mr-md-11{margin-right:44px!important}.v-application .mr-md-12{margin-right:48px!important}.v-application .mr-md-13{margin-right:52px!important}.v-application .mr-md-14{margin-right:56px!important}.v-application .mr-md-15{margin-right:60px!important}.v-application .mr-md-16{margin-right:64px!important}.v-application .mr-md-auto{margin-right:auto!important}.v-application .mb-md-0{margin-bottom:0!important}.v-application .mb-md-1{margin-bottom:4px!important}.v-application .mb-md-2{margin-bottom:8px!important}.v-application .mb-md-3{margin-bottom:12px!important}.v-application .mb-md-4{margin-bottom:16px!important}.v-application .mb-md-5{margin-bottom:20px!important}.v-application .mb-md-6{margin-bottom:24px!important}.v-application .mb-md-7{margin-bottom:28px!important}.v-application .mb-md-8{margin-bottom:32px!important}.v-application .mb-md-9{margin-bottom:36px!important}.v-application .mb-md-10{margin-bottom:40px!important}.v-application .mb-md-11{margin-bottom:44px!important}.v-application .mb-md-12{margin-bottom:48px!important}.v-application .mb-md-13{margin-bottom:52px!important}.v-application .mb-md-14{margin-bottom:56px!important}.v-application .mb-md-15{margin-bottom:60px!important}.v-application .mb-md-16{margin-bottom:64px!important}.v-application .mb-md-auto{margin-bottom:auto!important}.v-application .ml-md-0{margin-left:0!important}.v-application .ml-md-1{margin-left:4px!important}.v-application .ml-md-2{margin-left:8px!important}.v-application .ml-md-3{margin-left:12px!important}.v-application .ml-md-4{margin-left:16px!important}.v-application .ml-md-5{margin-left:20px!important}.v-application .ml-md-6{margin-left:24px!important}.v-application .ml-md-7{margin-left:28px!important}.v-application .ml-md-8{margin-left:32px!important}.v-application .ml-md-9{margin-left:36px!important}.v-application .ml-md-10{margin-left:40px!important}.v-application .ml-md-11{margin-left:44px!important}.v-application .ml-md-12{margin-left:48px!important}.v-application .ml-md-13{margin-left:52px!important}.v-application .ml-md-14{margin-left:56px!important}.v-application .ml-md-15{margin-left:60px!important}.v-application .ml-md-16{margin-left:64px!important}.v-application .ml-md-auto{margin-left:auto!important}.v-application--is-ltr .ms-md-0{margin-left:0!important}.v-application--is-rtl .ms-md-0{margin-right:0!important}.v-application--is-ltr .ms-md-1{margin-left:4px!important}.v-application--is-rtl .ms-md-1{margin-right:4px!important}.v-application--is-ltr .ms-md-2{margin-left:8px!important}.v-application--is-rtl .ms-md-2{margin-right:8px!important}.v-application--is-ltr .ms-md-3{margin-left:12px!important}.v-application--is-rtl .ms-md-3{margin-right:12px!important}.v-application--is-ltr .ms-md-4{margin-left:16px!important}.v-application--is-rtl .ms-md-4{margin-right:16px!important}.v-application--is-ltr .ms-md-5{margin-left:20px!important}.v-application--is-rtl .ms-md-5{margin-right:20px!important}.v-application--is-ltr .ms-md-6{margin-left:24px!important}.v-application--is-rtl .ms-md-6{margin-right:24px!important}.v-application--is-ltr .ms-md-7{margin-left:28px!important}.v-application--is-rtl .ms-md-7{margin-right:28px!important}.v-application--is-ltr .ms-md-8{margin-left:32px!important}.v-application--is-rtl .ms-md-8{margin-right:32px!important}.v-application--is-ltr .ms-md-9{margin-left:36px!important}.v-application--is-rtl .ms-md-9{margin-right:36px!important}.v-application--is-ltr .ms-md-10{margin-left:40px!important}.v-application--is-rtl .ms-md-10{margin-right:40px!important}.v-application--is-ltr .ms-md-11{margin-left:44px!important}.v-application--is-rtl .ms-md-11{margin-right:44px!important}.v-application--is-ltr .ms-md-12{margin-left:48px!important}.v-application--is-rtl .ms-md-12{margin-right:48px!important}.v-application--is-ltr .ms-md-13{margin-left:52px!important}.v-application--is-rtl .ms-md-13{margin-right:52px!important}.v-application--is-ltr .ms-md-14{margin-left:56px!important}.v-application--is-rtl .ms-md-14{margin-right:56px!important}.v-application--is-ltr .ms-md-15{margin-left:60px!important}.v-application--is-rtl .ms-md-15{margin-right:60px!important}.v-application--is-ltr .ms-md-16{margin-left:64px!important}.v-application--is-rtl .ms-md-16{margin-right:64px!important}.v-application--is-ltr .ms-md-auto{margin-left:auto!important}.v-application--is-rtl .ms-md-auto{margin-right:auto!important}.v-application--is-ltr .me-md-0{margin-right:0!important}.v-application--is-rtl .me-md-0{margin-left:0!important}.v-application--is-ltr .me-md-1{margin-right:4px!important}.v-application--is-rtl .me-md-1{margin-left:4px!important}.v-application--is-ltr .me-md-2{margin-right:8px!important}.v-application--is-rtl .me-md-2{margin-left:8px!important}.v-application--is-ltr .me-md-3{margin-right:12px!important}.v-application--is-rtl .me-md-3{margin-left:12px!important}.v-application--is-ltr .me-md-4{margin-right:16px!important}.v-application--is-rtl .me-md-4{margin-left:16px!important}.v-application--is-ltr .me-md-5{margin-right:20px!important}.v-application--is-rtl .me-md-5{margin-left:20px!important}.v-application--is-ltr .me-md-6{margin-right:24px!important}.v-application--is-rtl .me-md-6{margin-left:24px!important}.v-application--is-ltr .me-md-7{margin-right:28px!important}.v-application--is-rtl .me-md-7{margin-left:28px!important}.v-application--is-ltr .me-md-8{margin-right:32px!important}.v-application--is-rtl .me-md-8{margin-left:32px!important}.v-application--is-ltr .me-md-9{margin-right:36px!important}.v-application--is-rtl .me-md-9{margin-left:36px!important}.v-application--is-ltr .me-md-10{margin-right:40px!important}.v-application--is-rtl .me-md-10{margin-left:40px!important}.v-application--is-ltr .me-md-11{margin-right:44px!important}.v-application--is-rtl .me-md-11{margin-left:44px!important}.v-application--is-ltr .me-md-12{margin-right:48px!important}.v-application--is-rtl .me-md-12{margin-left:48px!important}.v-application--is-ltr .me-md-13{margin-right:52px!important}.v-application--is-rtl .me-md-13{margin-left:52px!important}.v-application--is-ltr .me-md-14{margin-right:56px!important}.v-application--is-rtl .me-md-14{margin-left:56px!important}.v-application--is-ltr .me-md-15{margin-right:60px!important}.v-application--is-rtl .me-md-15{margin-left:60px!important}.v-application--is-ltr .me-md-16{margin-right:64px!important}.v-application--is-rtl .me-md-16{margin-left:64px!important}.v-application--is-ltr .me-md-auto{margin-right:auto!important}.v-application--is-rtl .me-md-auto{margin-left:auto!important}.v-application .ma-md-n1{margin:-4px!important}.v-application .ma-md-n2{margin:-8px!important}.v-application .ma-md-n3{margin:-12px!important}.v-application .ma-md-n4{margin:-16px!important}.v-application .ma-md-n5{margin:-20px!important}.v-application .ma-md-n6{margin:-24px!important}.v-application .ma-md-n7{margin:-28px!important}.v-application .ma-md-n8{margin:-32px!important}.v-application .ma-md-n9{margin:-36px!important}.v-application .ma-md-n10{margin:-40px!important}.v-application .ma-md-n11{margin:-44px!important}.v-application .ma-md-n12{margin:-48px!important}.v-application .ma-md-n13{margin:-52px!important}.v-application .ma-md-n14{margin:-56px!important}.v-application .ma-md-n15{margin:-60px!important}.v-application .ma-md-n16{margin:-64px!important}.v-application .mx-md-n1{margin-right:-4px!important;margin-left:-4px!important}.v-application .mx-md-n2{margin-right:-8px!important;margin-left:-8px!important}.v-application .mx-md-n3{margin-right:-12px!important;margin-left:-12px!important}.v-application .mx-md-n4{margin-right:-16px!important;margin-left:-16px!important}.v-application .mx-md-n5{margin-right:-20px!important;margin-left:-20px!important}.v-application .mx-md-n6{margin-right:-24px!important;margin-left:-24px!important}.v-application .mx-md-n7{margin-right:-28px!important;margin-left:-28px!important}.v-application .mx-md-n8{margin-right:-32px!important;margin-left:-32px!important}.v-application .mx-md-n9{margin-right:-36px!important;margin-left:-36px!important}.v-application .mx-md-n10{margin-right:-40px!important;margin-left:-40px!important}.v-application .mx-md-n11{margin-right:-44px!important;margin-left:-44px!important}.v-application .mx-md-n12{margin-right:-48px!important;margin-left:-48px!important}.v-application .mx-md-n13{margin-right:-52px!important;margin-left:-52px!important}.v-application .mx-md-n14{margin-right:-56px!important;margin-left:-56px!important}.v-application .mx-md-n15{margin-right:-60px!important;margin-left:-60px!important}.v-application .mx-md-n16{margin-right:-64px!important;margin-left:-64px!important}.v-application .my-md-n1{margin-top:-4px!important;margin-bottom:-4px!important}.v-application .my-md-n2{margin-top:-8px!important;margin-bottom:-8px!important}.v-application .my-md-n3{margin-top:-12px!important;margin-bottom:-12px!important}.v-application .my-md-n4{margin-top:-16px!important;margin-bottom:-16px!important}.v-application .my-md-n5{margin-top:-20px!important;margin-bottom:-20px!important}.v-application .my-md-n6{margin-top:-24px!important;margin-bottom:-24px!important}.v-application .my-md-n7{margin-top:-28px!important;margin-bottom:-28px!important}.v-application .my-md-n8{margin-top:-32px!important;margin-bottom:-32px!important}.v-application .my-md-n9{margin-top:-36px!important;margin-bottom:-36px!important}.v-application .my-md-n10{margin-top:-40px!important;margin-bottom:-40px!important}.v-application .my-md-n11{margin-top:-44px!important;margin-bottom:-44px!important}.v-application .my-md-n12{margin-top:-48px!important;margin-bottom:-48px!important}.v-application .my-md-n13{margin-top:-52px!important;margin-bottom:-52px!important}.v-application .my-md-n14{margin-top:-56px!important;margin-bottom:-56px!important}.v-application .my-md-n15{margin-top:-60px!important;margin-bottom:-60px!important}.v-application .my-md-n16{margin-top:-64px!important;margin-bottom:-64px!important}.v-application .mt-md-n1{margin-top:-4px!important}.v-application .mt-md-n2{margin-top:-8px!important}.v-application .mt-md-n3{margin-top:-12px!important}.v-application .mt-md-n4{margin-top:-16px!important}.v-application .mt-md-n5{margin-top:-20px!important}.v-application .mt-md-n6{margin-top:-24px!important}.v-application .mt-md-n7{margin-top:-28px!important}.v-application .mt-md-n8{margin-top:-32px!important}.v-application .mt-md-n9{margin-top:-36px!important}.v-application .mt-md-n10{margin-top:-40px!important}.v-application .mt-md-n11{margin-top:-44px!important}.v-application .mt-md-n12{margin-top:-48px!important}.v-application .mt-md-n13{margin-top:-52px!important}.v-application .mt-md-n14{margin-top:-56px!important}.v-application .mt-md-n15{margin-top:-60px!important}.v-application .mt-md-n16{margin-top:-64px!important}.v-application .mr-md-n1{margin-right:-4px!important}.v-application .mr-md-n2{margin-right:-8px!important}.v-application .mr-md-n3{margin-right:-12px!important}.v-application .mr-md-n4{margin-right:-16px!important}.v-application .mr-md-n5{margin-right:-20px!important}.v-application .mr-md-n6{margin-right:-24px!important}.v-application .mr-md-n7{margin-right:-28px!important}.v-application .mr-md-n8{margin-right:-32px!important}.v-application .mr-md-n9{margin-right:-36px!important}.v-application .mr-md-n10{margin-right:-40px!important}.v-application .mr-md-n11{margin-right:-44px!important}.v-application .mr-md-n12{margin-right:-48px!important}.v-application .mr-md-n13{margin-right:-52px!important}.v-application .mr-md-n14{margin-right:-56px!important}.v-application .mr-md-n15{margin-right:-60px!important}.v-application .mr-md-n16{margin-right:-64px!important}.v-application .mb-md-n1{margin-bottom:-4px!important}.v-application .mb-md-n2{margin-bottom:-8px!important}.v-application .mb-md-n3{margin-bottom:-12px!important}.v-application .mb-md-n4{margin-bottom:-16px!important}.v-application .mb-md-n5{margin-bottom:-20px!important}.v-application .mb-md-n6{margin-bottom:-24px!important}.v-application .mb-md-n7{margin-bottom:-28px!important}.v-application .mb-md-n8{margin-bottom:-32px!important}.v-application .mb-md-n9{margin-bottom:-36px!important}.v-application .mb-md-n10{margin-bottom:-40px!important}.v-application .mb-md-n11{margin-bottom:-44px!important}.v-application .mb-md-n12{margin-bottom:-48px!important}.v-application .mb-md-n13{margin-bottom:-52px!important}.v-application .mb-md-n14{margin-bottom:-56px!important}.v-application .mb-md-n15{margin-bottom:-60px!important}.v-application .mb-md-n16{margin-bottom:-64px!important}.v-application .ml-md-n1{margin-left:-4px!important}.v-application .ml-md-n2{margin-left:-8px!important}.v-application .ml-md-n3{margin-left:-12px!important}.v-application .ml-md-n4{margin-left:-16px!important}.v-application .ml-md-n5{margin-left:-20px!important}.v-application .ml-md-n6{margin-left:-24px!important}.v-application .ml-md-n7{margin-left:-28px!important}.v-application .ml-md-n8{margin-left:-32px!important}.v-application .ml-md-n9{margin-left:-36px!important}.v-application .ml-md-n10{margin-left:-40px!important}.v-application .ml-md-n11{margin-left:-44px!important}.v-application .ml-md-n12{margin-left:-48px!important}.v-application .ml-md-n13{margin-left:-52px!important}.v-application .ml-md-n14{margin-left:-56px!important}.v-application .ml-md-n15{margin-left:-60px!important}.v-application .ml-md-n16{margin-left:-64px!important}.v-application--is-ltr .ms-md-n1{margin-left:-4px!important}.v-application--is-rtl .ms-md-n1{margin-right:-4px!important}.v-application--is-ltr .ms-md-n2{margin-left:-8px!important}.v-application--is-rtl .ms-md-n2{margin-right:-8px!important}.v-application--is-ltr .ms-md-n3{margin-left:-12px!important}.v-application--is-rtl .ms-md-n3{margin-right:-12px!important}.v-application--is-ltr .ms-md-n4{margin-left:-16px!important}.v-application--is-rtl .ms-md-n4{margin-right:-16px!important}.v-application--is-ltr .ms-md-n5{margin-left:-20px!important}.v-application--is-rtl .ms-md-n5{margin-right:-20px!important}.v-application--is-ltr .ms-md-n6{margin-left:-24px!important}.v-application--is-rtl .ms-md-n6{margin-right:-24px!important}.v-application--is-ltr .ms-md-n7{margin-left:-28px!important}.v-application--is-rtl .ms-md-n7{margin-right:-28px!important}.v-application--is-ltr .ms-md-n8{margin-left:-32px!important}.v-application--is-rtl .ms-md-n8{margin-right:-32px!important}.v-application--is-ltr .ms-md-n9{margin-left:-36px!important}.v-application--is-rtl .ms-md-n9{margin-right:-36px!important}.v-application--is-ltr .ms-md-n10{margin-left:-40px!important}.v-application--is-rtl .ms-md-n10{margin-right:-40px!important}.v-application--is-ltr .ms-md-n11{margin-left:-44px!important}.v-application--is-rtl .ms-md-n11{margin-right:-44px!important}.v-application--is-ltr .ms-md-n12{margin-left:-48px!important}.v-application--is-rtl .ms-md-n12{margin-right:-48px!important}.v-application--is-ltr .ms-md-n13{margin-left:-52px!important}.v-application--is-rtl .ms-md-n13{margin-right:-52px!important}.v-application--is-ltr .ms-md-n14{margin-left:-56px!important}.v-application--is-rtl .ms-md-n14{margin-right:-56px!important}.v-application--is-ltr .ms-md-n15{margin-left:-60px!important}.v-application--is-rtl .ms-md-n15{margin-right:-60px!important}.v-application--is-ltr .ms-md-n16{margin-left:-64px!important}.v-application--is-rtl .ms-md-n16{margin-right:-64px!important}.v-application--is-ltr .me-md-n1{margin-right:-4px!important}.v-application--is-rtl .me-md-n1{margin-left:-4px!important}.v-application--is-ltr .me-md-n2{margin-right:-8px!important}.v-application--is-rtl .me-md-n2{margin-left:-8px!important}.v-application--is-ltr .me-md-n3{margin-right:-12px!important}.v-application--is-rtl .me-md-n3{margin-left:-12px!important}.v-application--is-ltr .me-md-n4{margin-right:-16px!important}.v-application--is-rtl .me-md-n4{margin-left:-16px!important}.v-application--is-ltr .me-md-n5{margin-right:-20px!important}.v-application--is-rtl .me-md-n5{margin-left:-20px!important}.v-application--is-ltr .me-md-n6{margin-right:-24px!important}.v-application--is-rtl .me-md-n6{margin-left:-24px!important}.v-application--is-ltr .me-md-n7{margin-right:-28px!important}.v-application--is-rtl .me-md-n7{margin-left:-28px!important}.v-application--is-ltr .me-md-n8{margin-right:-32px!important}.v-application--is-rtl .me-md-n8{margin-left:-32px!important}.v-application--is-ltr .me-md-n9{margin-right:-36px!important}.v-application--is-rtl .me-md-n9{margin-left:-36px!important}.v-application--is-ltr .me-md-n10{margin-right:-40px!important}.v-application--is-rtl .me-md-n10{margin-left:-40px!important}.v-application--is-ltr .me-md-n11{margin-right:-44px!important}.v-application--is-rtl .me-md-n11{margin-left:-44px!important}.v-application--is-ltr .me-md-n12{margin-right:-48px!important}.v-application--is-rtl .me-md-n12{margin-left:-48px!important}.v-application--is-ltr .me-md-n13{margin-right:-52px!important}.v-application--is-rtl .me-md-n13{margin-left:-52px!important}.v-application--is-ltr .me-md-n14{margin-right:-56px!important}.v-application--is-rtl .me-md-n14{margin-left:-56px!important}.v-application--is-ltr .me-md-n15{margin-right:-60px!important}.v-application--is-rtl .me-md-n15{margin-left:-60px!important}.v-application--is-ltr .me-md-n16{margin-right:-64px!important}.v-application--is-rtl .me-md-n16{margin-left:-64px!important}.v-application .pa-md-0{padding:0!important}.v-application .pa-md-1{padding:4px!important}.v-application .pa-md-2{padding:8px!important}.v-application .pa-md-3{padding:12px!important}.v-application .pa-md-4{padding:16px!important}.v-application .pa-md-5{padding:20px!important}.v-application .pa-md-6{padding:24px!important}.v-application .pa-md-7{padding:28px!important}.v-application .pa-md-8{padding:32px!important}.v-application .pa-md-9{padding:36px!important}.v-application .pa-md-10{padding:40px!important}.v-application .pa-md-11{padding:44px!important}.v-application .pa-md-12{padding:48px!important}.v-application .pa-md-13{padding:52px!important}.v-application .pa-md-14{padding:56px!important}.v-application .pa-md-15{padding:60px!important}.v-application .pa-md-16{padding:64px!important}.v-application .px-md-0{padding-right:0!important;padding-left:0!important}.v-application .px-md-1{padding-right:4px!important;padding-left:4px!important}.v-application .px-md-2{padding-right:8px!important;padding-left:8px!important}.v-application .px-md-3{padding-right:12px!important;padding-left:12px!important}.v-application .px-md-4{padding-right:16px!important;padding-left:16px!important}.v-application .px-md-5{padding-right:20px!important;padding-left:20px!important}.v-application .px-md-6{padding-right:24px!important;padding-left:24px!important}.v-application .px-md-7{padding-right:28px!important;padding-left:28px!important}.v-application .px-md-8{padding-right:32px!important;padding-left:32px!important}.v-application .px-md-9{padding-right:36px!important;padding-left:36px!important}.v-application .px-md-10{padding-right:40px!important;padding-left:40px!important}.v-application .px-md-11{padding-right:44px!important;padding-left:44px!important}.v-application .px-md-12{padding-right:48px!important;padding-left:48px!important}.v-application .px-md-13{padding-right:52px!important;padding-left:52px!important}.v-application .px-md-14{padding-right:56px!important;padding-left:56px!important}.v-application .px-md-15{padding-right:60px!important;padding-left:60px!important}.v-application .px-md-16{padding-right:64px!important;padding-left:64px!important}.v-application .py-md-0{padding-top:0!important;padding-bottom:0!important}.v-application .py-md-1{padding-top:4px!important;padding-bottom:4px!important}.v-application .py-md-2{padding-top:8px!important;padding-bottom:8px!important}.v-application .py-md-3{padding-top:12px!important;padding-bottom:12px!important}.v-application .py-md-4{padding-top:16px!important;padding-bottom:16px!important}.v-application .py-md-5{padding-top:20px!important;padding-bottom:20px!important}.v-application .py-md-6{padding-top:24px!important;padding-bottom:24px!important}.v-application .py-md-7{padding-top:28px!important;padding-bottom:28px!important}.v-application .py-md-8{padding-top:32px!important;padding-bottom:32px!important}.v-application .py-md-9{padding-top:36px!important;padding-bottom:36px!important}.v-application .py-md-10{padding-top:40px!important;padding-bottom:40px!important}.v-application .py-md-11{padding-top:44px!important;padding-bottom:44px!important}.v-application .py-md-12{padding-top:48px!important;padding-bottom:48px!important}.v-application .py-md-13{padding-top:52px!important;padding-bottom:52px!important}.v-application .py-md-14{padding-top:56px!important;padding-bottom:56px!important}.v-application .py-md-15{padding-top:60px!important;padding-bottom:60px!important}.v-application .py-md-16{padding-top:64px!important;padding-bottom:64px!important}.v-application .pt-md-0{padding-top:0!important}.v-application .pt-md-1{padding-top:4px!important}.v-application .pt-md-2{padding-top:8px!important}.v-application .pt-md-3{padding-top:12px!important}.v-application .pt-md-4{padding-top:16px!important}.v-application .pt-md-5{padding-top:20px!important}.v-application .pt-md-6{padding-top:24px!important}.v-application .pt-md-7{padding-top:28px!important}.v-application .pt-md-8{padding-top:32px!important}.v-application .pt-md-9{padding-top:36px!important}.v-application .pt-md-10{padding-top:40px!important}.v-application .pt-md-11{padding-top:44px!important}.v-application .pt-md-12{padding-top:48px!important}.v-application .pt-md-13{padding-top:52px!important}.v-application .pt-md-14{padding-top:56px!important}.v-application .pt-md-15{padding-top:60px!important}.v-application .pt-md-16{padding-top:64px!important}.v-application .pr-md-0{padding-right:0!important}.v-application .pr-md-1{padding-right:4px!important}.v-application .pr-md-2{padding-right:8px!important}.v-application .pr-md-3{padding-right:12px!important}.v-application .pr-md-4{padding-right:16px!important}.v-application .pr-md-5{padding-right:20px!important}.v-application .pr-md-6{padding-right:24px!important}.v-application .pr-md-7{padding-right:28px!important}.v-application .pr-md-8{padding-right:32px!important}.v-application .pr-md-9{padding-right:36px!important}.v-application .pr-md-10{padding-right:40px!important}.v-application .pr-md-11{padding-right:44px!important}.v-application .pr-md-12{padding-right:48px!important}.v-application .pr-md-13{padding-right:52px!important}.v-application .pr-md-14{padding-right:56px!important}.v-application .pr-md-15{padding-right:60px!important}.v-application .pr-md-16{padding-right:64px!important}.v-application .pb-md-0{padding-bottom:0!important}.v-application .pb-md-1{padding-bottom:4px!important}.v-application .pb-md-2{padding-bottom:8px!important}.v-application .pb-md-3{padding-bottom:12px!important}.v-application .pb-md-4{padding-bottom:16px!important}.v-application .pb-md-5{padding-bottom:20px!important}.v-application .pb-md-6{padding-bottom:24px!important}.v-application .pb-md-7{padding-bottom:28px!important}.v-application .pb-md-8{padding-bottom:32px!important}.v-application .pb-md-9{padding-bottom:36px!important}.v-application .pb-md-10{padding-bottom:40px!important}.v-application .pb-md-11{padding-bottom:44px!important}.v-application .pb-md-12{padding-bottom:48px!important}.v-application .pb-md-13{padding-bottom:52px!important}.v-application .pb-md-14{padding-bottom:56px!important}.v-application .pb-md-15{padding-bottom:60px!important}.v-application .pb-md-16{padding-bottom:64px!important}.v-application .pl-md-0{padding-left:0!important}.v-application .pl-md-1{padding-left:4px!important}.v-application .pl-md-2{padding-left:8px!important}.v-application .pl-md-3{padding-left:12px!important}.v-application .pl-md-4{padding-left:16px!important}.v-application .pl-md-5{padding-left:20px!important}.v-application .pl-md-6{padding-left:24px!important}.v-application .pl-md-7{padding-left:28px!important}.v-application .pl-md-8{padding-left:32px!important}.v-application .pl-md-9{padding-left:36px!important}.v-application .pl-md-10{padding-left:40px!important}.v-application .pl-md-11{padding-left:44px!important}.v-application .pl-md-12{padding-left:48px!important}.v-application .pl-md-13{padding-left:52px!important}.v-application .pl-md-14{padding-left:56px!important}.v-application .pl-md-15{padding-left:60px!important}.v-application .pl-md-16{padding-left:64px!important}.v-application--is-ltr .ps-md-0{padding-left:0!important}.v-application--is-rtl .ps-md-0{padding-right:0!important}.v-application--is-ltr .ps-md-1{padding-left:4px!important}.v-application--is-rtl .ps-md-1{padding-right:4px!important}.v-application--is-ltr .ps-md-2{padding-left:8px!important}.v-application--is-rtl .ps-md-2{padding-right:8px!important}.v-application--is-ltr .ps-md-3{padding-left:12px!important}.v-application--is-rtl .ps-md-3{padding-right:12px!important}.v-application--is-ltr .ps-md-4{padding-left:16px!important}.v-application--is-rtl .ps-md-4{padding-right:16px!important}.v-application--is-ltr .ps-md-5{padding-left:20px!important}.v-application--is-rtl .ps-md-5{padding-right:20px!important}.v-application--is-ltr .ps-md-6{padding-left:24px!important}.v-application--is-rtl .ps-md-6{padding-right:24px!important}.v-application--is-ltr .ps-md-7{padding-left:28px!important}.v-application--is-rtl .ps-md-7{padding-right:28px!important}.v-application--is-ltr .ps-md-8{padding-left:32px!important}.v-application--is-rtl .ps-md-8{padding-right:32px!important}.v-application--is-ltr .ps-md-9{padding-left:36px!important}.v-application--is-rtl .ps-md-9{padding-right:36px!important}.v-application--is-ltr .ps-md-10{padding-left:40px!important}.v-application--is-rtl .ps-md-10{padding-right:40px!important}.v-application--is-ltr .ps-md-11{padding-left:44px!important}.v-application--is-rtl .ps-md-11{padding-right:44px!important}.v-application--is-ltr .ps-md-12{padding-left:48px!important}.v-application--is-rtl .ps-md-12{padding-right:48px!important}.v-application--is-ltr .ps-md-13{padding-left:52px!important}.v-application--is-rtl .ps-md-13{padding-right:52px!important}.v-application--is-ltr .ps-md-14{padding-left:56px!important}.v-application--is-rtl .ps-md-14{padding-right:56px!important}.v-application--is-ltr .ps-md-15{padding-left:60px!important}.v-application--is-rtl .ps-md-15{padding-right:60px!important}.v-application--is-ltr .ps-md-16{padding-left:64px!important}.v-application--is-rtl .ps-md-16{padding-right:64px!important}.v-application--is-ltr .pe-md-0{padding-right:0!important}.v-application--is-rtl .pe-md-0{padding-left:0!important}.v-application--is-ltr .pe-md-1{padding-right:4px!important}.v-application--is-rtl .pe-md-1{padding-left:4px!important}.v-application--is-ltr .pe-md-2{padding-right:8px!important}.v-application--is-rtl .pe-md-2{padding-left:8px!important}.v-application--is-ltr .pe-md-3{padding-right:12px!important}.v-application--is-rtl .pe-md-3{padding-left:12px!important}.v-application--is-ltr .pe-md-4{padding-right:16px!important}.v-application--is-rtl .pe-md-4{padding-left:16px!important}.v-application--is-ltr .pe-md-5{padding-right:20px!important}.v-application--is-rtl .pe-md-5{padding-left:20px!important}.v-application--is-ltr .pe-md-6{padding-right:24px!important}.v-application--is-rtl .pe-md-6{padding-left:24px!important}.v-application--is-ltr .pe-md-7{padding-right:28px!important}.v-application--is-rtl .pe-md-7{padding-left:28px!important}.v-application--is-ltr .pe-md-8{padding-right:32px!important}.v-application--is-rtl .pe-md-8{padding-left:32px!important}.v-application--is-ltr .pe-md-9{padding-right:36px!important}.v-application--is-rtl .pe-md-9{padding-left:36px!important}.v-application--is-ltr .pe-md-10{padding-right:40px!important}.v-application--is-rtl .pe-md-10{padding-left:40px!important}.v-application--is-ltr .pe-md-11{padding-right:44px!important}.v-application--is-rtl .pe-md-11{padding-left:44px!important}.v-application--is-ltr .pe-md-12{padding-right:48px!important}.v-application--is-rtl .pe-md-12{padding-left:48px!important}.v-application--is-ltr .pe-md-13{padding-right:52px!important}.v-application--is-rtl .pe-md-13{padding-left:52px!important}.v-application--is-ltr .pe-md-14{padding-right:56px!important}.v-application--is-rtl .pe-md-14{padding-left:56px!important}.v-application--is-ltr .pe-md-15{padding-right:60px!important}.v-application--is-rtl .pe-md-15{padding-left:60px!important}.v-application--is-ltr .pe-md-16{padding-right:64px!important}.v-application--is-rtl .pe-md-16{padding-left:64px!important}.v-application .text-md-left{text-align:left!important}.v-application .text-md-right{text-align:right!important}.v-application .text-md-center{text-align:center!important}.v-application .text-md-justify{text-align:justify!important}.v-application .text-md-start{text-align:start!important}.v-application .text-md-end{text-align:end!important}.v-application .text-md-h1{font-size:6rem!important;line-height:6rem;letter-spacing:-.015625em!important}.v-application .text-md-h1,.v-application .text-md-h2{font-weight:300;font-family:Roboto,sans-serif!important}.v-application .text-md-h2{font-size:3.75rem!important;line-height:3.75rem;letter-spacing:-.0083333333em!important}.v-application .text-md-h3{font-size:3rem!important;line-height:3.125rem;letter-spacing:normal!important}.v-application .text-md-h3,.v-application .text-md-h4{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .text-md-h4{font-size:2.125rem!important;line-height:2.5rem;letter-spacing:.0073529412em!important}.v-application .text-md-h5{font-size:1.5rem!important;font-weight:400;letter-spacing:normal!important}.v-application .text-md-h5,.v-application .text-md-h6{line-height:2rem;font-family:Roboto,sans-serif!important}.v-application .text-md-h6{font-size:1.25rem!important;font-weight:500;letter-spacing:.0125em!important}.v-application .text-md-subtitle-1{font-size:1rem!important;font-weight:400;line-height:1.75rem;letter-spacing:.009375em!important;font-family:Roboto,sans-serif!important}.v-application .text-md-subtitle-2{font-size:.875rem!important;font-weight:500;line-height:1.375rem;letter-spacing:.0071428571em!important;font-family:Roboto,sans-serif!important}.v-application .text-md-body-1{font-size:1rem!important;font-weight:400;line-height:1.5rem;letter-spacing:.03125em!important;font-family:Roboto,sans-serif!important}.v-application .text-md-body-2{font-weight:400;line-height:1.25rem;letter-spacing:.0178571429em!important}.v-application .text-md-body-2,.v-application .text-md-button{font-size:.875rem!important;font-family:Roboto,sans-serif!important}.v-application .text-md-button{font-weight:500;line-height:2.25rem;letter-spacing:.0892857143em!important;text-transform:uppercase!important}.v-application .text-md-caption{font-weight:400;line-height:1.25rem;letter-spacing:.0333333333em!important}.v-application .text-md-caption,.v-application .text-md-overline{font-size:.75rem!important;font-family:Roboto,sans-serif!important}.v-application .text-md-overline{font-weight:500;line-height:2rem;letter-spacing:.1666666667em!important;text-transform:uppercase!important}}@media(min-width:1264px){.v-application .d-lg-none{display:none!important}.v-application .d-lg-inline{display:inline!important}.v-application .d-lg-inline-block{display:inline-block!important}.v-application .d-lg-block{display:block!important}.v-application .d-lg-table{display:table!important}.v-application .d-lg-table-row{display:table-row!important}.v-application .d-lg-table-cell{display:table-cell!important}.v-application .d-lg-flex{display:flex!important}.v-application .d-lg-inline-flex{display:inline-flex!important}.v-application .float-lg-none{float:none!important}.v-application .float-lg-left{float:left!important}.v-application .float-lg-right{float:right!important}.v-application--is-rtl .float-lg-end{float:left!important}.v-application--is-ltr .float-lg-end,.v-application--is-rtl .float-lg-start{float:right!important}.v-application--is-ltr .float-lg-start{float:left!important}.v-application .flex-lg-fill{flex:1 1 auto!important}.v-application .flex-lg-row{flex-direction:row!important}.v-application .flex-lg-column{flex-direction:column!important}.v-application .flex-lg-row-reverse{flex-direction:row-reverse!important}.v-application .flex-lg-column-reverse{flex-direction:column-reverse!important}.v-application .flex-lg-grow-0{flex-grow:0!important}.v-application .flex-lg-grow-1{flex-grow:1!important}.v-application .flex-lg-shrink-0{flex-shrink:0!important}.v-application .flex-lg-shrink-1{flex-shrink:1!important}.v-application .flex-lg-wrap{flex-wrap:wrap!important}.v-application .flex-lg-nowrap{flex-wrap:nowrap!important}.v-application .flex-lg-wrap-reverse{flex-wrap:wrap-reverse!important}.v-application .justify-lg-start{justify-content:flex-start!important}.v-application .justify-lg-end{justify-content:flex-end!important}.v-application .justify-lg-center{justify-content:center!important}.v-application .justify-lg-space-between{justify-content:space-between!important}.v-application .justify-lg-space-around{justify-content:space-around!important}.v-application .align-lg-start{align-items:flex-start!important}.v-application .align-lg-end{align-items:flex-end!important}.v-application .align-lg-center{align-items:center!important}.v-application .align-lg-baseline{align-items:baseline!important}.v-application .align-lg-stretch{align-items:stretch!important}.v-application .align-content-lg-start{align-content:flex-start!important}.v-application .align-content-lg-end{align-content:flex-end!important}.v-application .align-content-lg-center{align-content:center!important}.v-application .align-content-lg-space-between{align-content:space-between!important}.v-application .align-content-lg-space-around{align-content:space-around!important}.v-application .align-content-lg-stretch{align-content:stretch!important}.v-application .align-self-lg-auto{align-self:auto!important}.v-application .align-self-lg-start{align-self:flex-start!important}.v-application .align-self-lg-end{align-self:flex-end!important}.v-application .align-self-lg-center{align-self:center!important}.v-application .align-self-lg-baseline{align-self:baseline!important}.v-application .align-self-lg-stretch{align-self:stretch!important}.v-application .order-lg-first{order:-1!important}.v-application .order-lg-0{order:0!important}.v-application .order-lg-1{order:1!important}.v-application .order-lg-2{order:2!important}.v-application .order-lg-3{order:3!important}.v-application .order-lg-4{order:4!important}.v-application .order-lg-5{order:5!important}.v-application .order-lg-6{order:6!important}.v-application .order-lg-7{order:7!important}.v-application .order-lg-8{order:8!important}.v-application .order-lg-9{order:9!important}.v-application .order-lg-10{order:10!important}.v-application .order-lg-11{order:11!important}.v-application .order-lg-12{order:12!important}.v-application .order-lg-last{order:13!important}.v-application .ma-lg-0{margin:0!important}.v-application .ma-lg-1{margin:4px!important}.v-application .ma-lg-2{margin:8px!important}.v-application .ma-lg-3{margin:12px!important}.v-application .ma-lg-4{margin:16px!important}.v-application .ma-lg-5{margin:20px!important}.v-application .ma-lg-6{margin:24px!important}.v-application .ma-lg-7{margin:28px!important}.v-application .ma-lg-8{margin:32px!important}.v-application .ma-lg-9{margin:36px!important}.v-application .ma-lg-10{margin:40px!important}.v-application .ma-lg-11{margin:44px!important}.v-application .ma-lg-12{margin:48px!important}.v-application .ma-lg-13{margin:52px!important}.v-application .ma-lg-14{margin:56px!important}.v-application .ma-lg-15{margin:60px!important}.v-application .ma-lg-16{margin:64px!important}.v-application .ma-lg-auto{margin:auto!important}.v-application .mx-lg-0{margin-right:0!important;margin-left:0!important}.v-application .mx-lg-1{margin-right:4px!important;margin-left:4px!important}.v-application .mx-lg-2{margin-right:8px!important;margin-left:8px!important}.v-application .mx-lg-3{margin-right:12px!important;margin-left:12px!important}.v-application .mx-lg-4{margin-right:16px!important;margin-left:16px!important}.v-application .mx-lg-5{margin-right:20px!important;margin-left:20px!important}.v-application .mx-lg-6{margin-right:24px!important;margin-left:24px!important}.v-application .mx-lg-7{margin-right:28px!important;margin-left:28px!important}.v-application .mx-lg-8{margin-right:32px!important;margin-left:32px!important}.v-application .mx-lg-9{margin-right:36px!important;margin-left:36px!important}.v-application .mx-lg-10{margin-right:40px!important;margin-left:40px!important}.v-application .mx-lg-11{margin-right:44px!important;margin-left:44px!important}.v-application .mx-lg-12{margin-right:48px!important;margin-left:48px!important}.v-application .mx-lg-13{margin-right:52px!important;margin-left:52px!important}.v-application .mx-lg-14{margin-right:56px!important;margin-left:56px!important}.v-application .mx-lg-15{margin-right:60px!important;margin-left:60px!important}.v-application .mx-lg-16{margin-right:64px!important;margin-left:64px!important}.v-application .mx-lg-auto{margin-right:auto!important;margin-left:auto!important}.v-application .my-lg-0{margin-top:0!important;margin-bottom:0!important}.v-application .my-lg-1{margin-top:4px!important;margin-bottom:4px!important}.v-application .my-lg-2{margin-top:8px!important;margin-bottom:8px!important}.v-application .my-lg-3{margin-top:12px!important;margin-bottom:12px!important}.v-application .my-lg-4{margin-top:16px!important;margin-bottom:16px!important}.v-application .my-lg-5{margin-top:20px!important;margin-bottom:20px!important}.v-application .my-lg-6{margin-top:24px!important;margin-bottom:24px!important}.v-application .my-lg-7{margin-top:28px!important;margin-bottom:28px!important}.v-application .my-lg-8{margin-top:32px!important;margin-bottom:32px!important}.v-application .my-lg-9{margin-top:36px!important;margin-bottom:36px!important}.v-application .my-lg-10{margin-top:40px!important;margin-bottom:40px!important}.v-application .my-lg-11{margin-top:44px!important;margin-bottom:44px!important}.v-application .my-lg-12{margin-top:48px!important;margin-bottom:48px!important}.v-application .my-lg-13{margin-top:52px!important;margin-bottom:52px!important}.v-application .my-lg-14{margin-top:56px!important;margin-bottom:56px!important}.v-application .my-lg-15{margin-top:60px!important;margin-bottom:60px!important}.v-application .my-lg-16{margin-top:64px!important;margin-bottom:64px!important}.v-application .my-lg-auto{margin-top:auto!important;margin-bottom:auto!important}.v-application .mt-lg-0{margin-top:0!important}.v-application .mt-lg-1{margin-top:4px!important}.v-application .mt-lg-2{margin-top:8px!important}.v-application .mt-lg-3{margin-top:12px!important}.v-application .mt-lg-4{margin-top:16px!important}.v-application .mt-lg-5{margin-top:20px!important}.v-application .mt-lg-6{margin-top:24px!important}.v-application .mt-lg-7{margin-top:28px!important}.v-application .mt-lg-8{margin-top:32px!important}.v-application .mt-lg-9{margin-top:36px!important}.v-application .mt-lg-10{margin-top:40px!important}.v-application .mt-lg-11{margin-top:44px!important}.v-application .mt-lg-12{margin-top:48px!important}.v-application .mt-lg-13{margin-top:52px!important}.v-application .mt-lg-14{margin-top:56px!important}.v-application .mt-lg-15{margin-top:60px!important}.v-application .mt-lg-16{margin-top:64px!important}.v-application .mt-lg-auto{margin-top:auto!important}.v-application .mr-lg-0{margin-right:0!important}.v-application .mr-lg-1{margin-right:4px!important}.v-application .mr-lg-2{margin-right:8px!important}.v-application .mr-lg-3{margin-right:12px!important}.v-application .mr-lg-4{margin-right:16px!important}.v-application .mr-lg-5{margin-right:20px!important}.v-application .mr-lg-6{margin-right:24px!important}.v-application .mr-lg-7{margin-right:28px!important}.v-application .mr-lg-8{margin-right:32px!important}.v-application .mr-lg-9{margin-right:36px!important}.v-application .mr-lg-10{margin-right:40px!important}.v-application .mr-lg-11{margin-right:44px!important}.v-application .mr-lg-12{margin-right:48px!important}.v-application .mr-lg-13{margin-right:52px!important}.v-application .mr-lg-14{margin-right:56px!important}.v-application .mr-lg-15{margin-right:60px!important}.v-application .mr-lg-16{margin-right:64px!important}.v-application .mr-lg-auto{margin-right:auto!important}.v-application .mb-lg-0{margin-bottom:0!important}.v-application .mb-lg-1{margin-bottom:4px!important}.v-application .mb-lg-2{margin-bottom:8px!important}.v-application .mb-lg-3{margin-bottom:12px!important}.v-application .mb-lg-4{margin-bottom:16px!important}.v-application .mb-lg-5{margin-bottom:20px!important}.v-application .mb-lg-6{margin-bottom:24px!important}.v-application .mb-lg-7{margin-bottom:28px!important}.v-application .mb-lg-8{margin-bottom:32px!important}.v-application .mb-lg-9{margin-bottom:36px!important}.v-application .mb-lg-10{margin-bottom:40px!important}.v-application .mb-lg-11{margin-bottom:44px!important}.v-application .mb-lg-12{margin-bottom:48px!important}.v-application .mb-lg-13{margin-bottom:52px!important}.v-application .mb-lg-14{margin-bottom:56px!important}.v-application .mb-lg-15{margin-bottom:60px!important}.v-application .mb-lg-16{margin-bottom:64px!important}.v-application .mb-lg-auto{margin-bottom:auto!important}.v-application .ml-lg-0{margin-left:0!important}.v-application .ml-lg-1{margin-left:4px!important}.v-application .ml-lg-2{margin-left:8px!important}.v-application .ml-lg-3{margin-left:12px!important}.v-application .ml-lg-4{margin-left:16px!important}.v-application .ml-lg-5{margin-left:20px!important}.v-application .ml-lg-6{margin-left:24px!important}.v-application .ml-lg-7{margin-left:28px!important}.v-application .ml-lg-8{margin-left:32px!important}.v-application .ml-lg-9{margin-left:36px!important}.v-application .ml-lg-10{margin-left:40px!important}.v-application .ml-lg-11{margin-left:44px!important}.v-application .ml-lg-12{margin-left:48px!important}.v-application .ml-lg-13{margin-left:52px!important}.v-application .ml-lg-14{margin-left:56px!important}.v-application .ml-lg-15{margin-left:60px!important}.v-application .ml-lg-16{margin-left:64px!important}.v-application .ml-lg-auto{margin-left:auto!important}.v-application--is-ltr .ms-lg-0{margin-left:0!important}.v-application--is-rtl .ms-lg-0{margin-right:0!important}.v-application--is-ltr .ms-lg-1{margin-left:4px!important}.v-application--is-rtl .ms-lg-1{margin-right:4px!important}.v-application--is-ltr .ms-lg-2{margin-left:8px!important}.v-application--is-rtl .ms-lg-2{margin-right:8px!important}.v-application--is-ltr .ms-lg-3{margin-left:12px!important}.v-application--is-rtl .ms-lg-3{margin-right:12px!important}.v-application--is-ltr .ms-lg-4{margin-left:16px!important}.v-application--is-rtl .ms-lg-4{margin-right:16px!important}.v-application--is-ltr .ms-lg-5{margin-left:20px!important}.v-application--is-rtl .ms-lg-5{margin-right:20px!important}.v-application--is-ltr .ms-lg-6{margin-left:24px!important}.v-application--is-rtl .ms-lg-6{margin-right:24px!important}.v-application--is-ltr .ms-lg-7{margin-left:28px!important}.v-application--is-rtl .ms-lg-7{margin-right:28px!important}.v-application--is-ltr .ms-lg-8{margin-left:32px!important}.v-application--is-rtl .ms-lg-8{margin-right:32px!important}.v-application--is-ltr .ms-lg-9{margin-left:36px!important}.v-application--is-rtl .ms-lg-9{margin-right:36px!important}.v-application--is-ltr .ms-lg-10{margin-left:40px!important}.v-application--is-rtl .ms-lg-10{margin-right:40px!important}.v-application--is-ltr .ms-lg-11{margin-left:44px!important}.v-application--is-rtl .ms-lg-11{margin-right:44px!important}.v-application--is-ltr .ms-lg-12{margin-left:48px!important}.v-application--is-rtl .ms-lg-12{margin-right:48px!important}.v-application--is-ltr .ms-lg-13{margin-left:52px!important}.v-application--is-rtl .ms-lg-13{margin-right:52px!important}.v-application--is-ltr .ms-lg-14{margin-left:56px!important}.v-application--is-rtl .ms-lg-14{margin-right:56px!important}.v-application--is-ltr .ms-lg-15{margin-left:60px!important}.v-application--is-rtl .ms-lg-15{margin-right:60px!important}.v-application--is-ltr .ms-lg-16{margin-left:64px!important}.v-application--is-rtl .ms-lg-16{margin-right:64px!important}.v-application--is-ltr .ms-lg-auto{margin-left:auto!important}.v-application--is-rtl .ms-lg-auto{margin-right:auto!important}.v-application--is-ltr .me-lg-0{margin-right:0!important}.v-application--is-rtl .me-lg-0{margin-left:0!important}.v-application--is-ltr .me-lg-1{margin-right:4px!important}.v-application--is-rtl .me-lg-1{margin-left:4px!important}.v-application--is-ltr .me-lg-2{margin-right:8px!important}.v-application--is-rtl .me-lg-2{margin-left:8px!important}.v-application--is-ltr .me-lg-3{margin-right:12px!important}.v-application--is-rtl .me-lg-3{margin-left:12px!important}.v-application--is-ltr .me-lg-4{margin-right:16px!important}.v-application--is-rtl .me-lg-4{margin-left:16px!important}.v-application--is-ltr .me-lg-5{margin-right:20px!important}.v-application--is-rtl .me-lg-5{margin-left:20px!important}.v-application--is-ltr .me-lg-6{margin-right:24px!important}.v-application--is-rtl .me-lg-6{margin-left:24px!important}.v-application--is-ltr .me-lg-7{margin-right:28px!important}.v-application--is-rtl .me-lg-7{margin-left:28px!important}.v-application--is-ltr .me-lg-8{margin-right:32px!important}.v-application--is-rtl .me-lg-8{margin-left:32px!important}.v-application--is-ltr .me-lg-9{margin-right:36px!important}.v-application--is-rtl .me-lg-9{margin-left:36px!important}.v-application--is-ltr .me-lg-10{margin-right:40px!important}.v-application--is-rtl .me-lg-10{margin-left:40px!important}.v-application--is-ltr .me-lg-11{margin-right:44px!important}.v-application--is-rtl .me-lg-11{margin-left:44px!important}.v-application--is-ltr .me-lg-12{margin-right:48px!important}.v-application--is-rtl .me-lg-12{margin-left:48px!important}.v-application--is-ltr .me-lg-13{margin-right:52px!important}.v-application--is-rtl .me-lg-13{margin-left:52px!important}.v-application--is-ltr .me-lg-14{margin-right:56px!important}.v-application--is-rtl .me-lg-14{margin-left:56px!important}.v-application--is-ltr .me-lg-15{margin-right:60px!important}.v-application--is-rtl .me-lg-15{margin-left:60px!important}.v-application--is-ltr .me-lg-16{margin-right:64px!important}.v-application--is-rtl .me-lg-16{margin-left:64px!important}.v-application--is-ltr .me-lg-auto{margin-right:auto!important}.v-application--is-rtl .me-lg-auto{margin-left:auto!important}.v-application .ma-lg-n1{margin:-4px!important}.v-application .ma-lg-n2{margin:-8px!important}.v-application .ma-lg-n3{margin:-12px!important}.v-application .ma-lg-n4{margin:-16px!important}.v-application .ma-lg-n5{margin:-20px!important}.v-application .ma-lg-n6{margin:-24px!important}.v-application .ma-lg-n7{margin:-28px!important}.v-application .ma-lg-n8{margin:-32px!important}.v-application .ma-lg-n9{margin:-36px!important}.v-application .ma-lg-n10{margin:-40px!important}.v-application .ma-lg-n11{margin:-44px!important}.v-application .ma-lg-n12{margin:-48px!important}.v-application .ma-lg-n13{margin:-52px!important}.v-application .ma-lg-n14{margin:-56px!important}.v-application .ma-lg-n15{margin:-60px!important}.v-application .ma-lg-n16{margin:-64px!important}.v-application .mx-lg-n1{margin-right:-4px!important;margin-left:-4px!important}.v-application .mx-lg-n2{margin-right:-8px!important;margin-left:-8px!important}.v-application .mx-lg-n3{margin-right:-12px!important;margin-left:-12px!important}.v-application .mx-lg-n4{margin-right:-16px!important;margin-left:-16px!important}.v-application .mx-lg-n5{margin-right:-20px!important;margin-left:-20px!important}.v-application .mx-lg-n6{margin-right:-24px!important;margin-left:-24px!important}.v-application .mx-lg-n7{margin-right:-28px!important;margin-left:-28px!important}.v-application .mx-lg-n8{margin-right:-32px!important;margin-left:-32px!important}.v-application .mx-lg-n9{margin-right:-36px!important;margin-left:-36px!important}.v-application .mx-lg-n10{margin-right:-40px!important;margin-left:-40px!important}.v-application .mx-lg-n11{margin-right:-44px!important;margin-left:-44px!important}.v-application .mx-lg-n12{margin-right:-48px!important;margin-left:-48px!important}.v-application .mx-lg-n13{margin-right:-52px!important;margin-left:-52px!important}.v-application .mx-lg-n14{margin-right:-56px!important;margin-left:-56px!important}.v-application .mx-lg-n15{margin-right:-60px!important;margin-left:-60px!important}.v-application .mx-lg-n16{margin-right:-64px!important;margin-left:-64px!important}.v-application .my-lg-n1{margin-top:-4px!important;margin-bottom:-4px!important}.v-application .my-lg-n2{margin-top:-8px!important;margin-bottom:-8px!important}.v-application .my-lg-n3{margin-top:-12px!important;margin-bottom:-12px!important}.v-application .my-lg-n4{margin-top:-16px!important;margin-bottom:-16px!important}.v-application .my-lg-n5{margin-top:-20px!important;margin-bottom:-20px!important}.v-application .my-lg-n6{margin-top:-24px!important;margin-bottom:-24px!important}.v-application .my-lg-n7{margin-top:-28px!important;margin-bottom:-28px!important}.v-application .my-lg-n8{margin-top:-32px!important;margin-bottom:-32px!important}.v-application .my-lg-n9{margin-top:-36px!important;margin-bottom:-36px!important}.v-application .my-lg-n10{margin-top:-40px!important;margin-bottom:-40px!important}.v-application .my-lg-n11{margin-top:-44px!important;margin-bottom:-44px!important}.v-application .my-lg-n12{margin-top:-48px!important;margin-bottom:-48px!important}.v-application .my-lg-n13{margin-top:-52px!important;margin-bottom:-52px!important}.v-application .my-lg-n14{margin-top:-56px!important;margin-bottom:-56px!important}.v-application .my-lg-n15{margin-top:-60px!important;margin-bottom:-60px!important}.v-application .my-lg-n16{margin-top:-64px!important;margin-bottom:-64px!important}.v-application .mt-lg-n1{margin-top:-4px!important}.v-application .mt-lg-n2{margin-top:-8px!important}.v-application .mt-lg-n3{margin-top:-12px!important}.v-application .mt-lg-n4{margin-top:-16px!important}.v-application .mt-lg-n5{margin-top:-20px!important}.v-application .mt-lg-n6{margin-top:-24px!important}.v-application .mt-lg-n7{margin-top:-28px!important}.v-application .mt-lg-n8{margin-top:-32px!important}.v-application .mt-lg-n9{margin-top:-36px!important}.v-application .mt-lg-n10{margin-top:-40px!important}.v-application .mt-lg-n11{margin-top:-44px!important}.v-application .mt-lg-n12{margin-top:-48px!important}.v-application .mt-lg-n13{margin-top:-52px!important}.v-application .mt-lg-n14{margin-top:-56px!important}.v-application .mt-lg-n15{margin-top:-60px!important}.v-application .mt-lg-n16{margin-top:-64px!important}.v-application .mr-lg-n1{margin-right:-4px!important}.v-application .mr-lg-n2{margin-right:-8px!important}.v-application .mr-lg-n3{margin-right:-12px!important}.v-application .mr-lg-n4{margin-right:-16px!important}.v-application .mr-lg-n5{margin-right:-20px!important}.v-application .mr-lg-n6{margin-right:-24px!important}.v-application .mr-lg-n7{margin-right:-28px!important}.v-application .mr-lg-n8{margin-right:-32px!important}.v-application .mr-lg-n9{margin-right:-36px!important}.v-application .mr-lg-n10{margin-right:-40px!important}.v-application .mr-lg-n11{margin-right:-44px!important}.v-application .mr-lg-n12{margin-right:-48px!important}.v-application .mr-lg-n13{margin-right:-52px!important}.v-application .mr-lg-n14{margin-right:-56px!important}.v-application .mr-lg-n15{margin-right:-60px!important}.v-application .mr-lg-n16{margin-right:-64px!important}.v-application .mb-lg-n1{margin-bottom:-4px!important}.v-application .mb-lg-n2{margin-bottom:-8px!important}.v-application .mb-lg-n3{margin-bottom:-12px!important}.v-application .mb-lg-n4{margin-bottom:-16px!important}.v-application .mb-lg-n5{margin-bottom:-20px!important}.v-application .mb-lg-n6{margin-bottom:-24px!important}.v-application .mb-lg-n7{margin-bottom:-28px!important}.v-application .mb-lg-n8{margin-bottom:-32px!important}.v-application .mb-lg-n9{margin-bottom:-36px!important}.v-application .mb-lg-n10{margin-bottom:-40px!important}.v-application .mb-lg-n11{margin-bottom:-44px!important}.v-application .mb-lg-n12{margin-bottom:-48px!important}.v-application .mb-lg-n13{margin-bottom:-52px!important}.v-application .mb-lg-n14{margin-bottom:-56px!important}.v-application .mb-lg-n15{margin-bottom:-60px!important}.v-application .mb-lg-n16{margin-bottom:-64px!important}.v-application .ml-lg-n1{margin-left:-4px!important}.v-application .ml-lg-n2{margin-left:-8px!important}.v-application .ml-lg-n3{margin-left:-12px!important}.v-application .ml-lg-n4{margin-left:-16px!important}.v-application .ml-lg-n5{margin-left:-20px!important}.v-application .ml-lg-n6{margin-left:-24px!important}.v-application .ml-lg-n7{margin-left:-28px!important}.v-application .ml-lg-n8{margin-left:-32px!important}.v-application .ml-lg-n9{margin-left:-36px!important}.v-application .ml-lg-n10{margin-left:-40px!important}.v-application .ml-lg-n11{margin-left:-44px!important}.v-application .ml-lg-n12{margin-left:-48px!important}.v-application .ml-lg-n13{margin-left:-52px!important}.v-application .ml-lg-n14{margin-left:-56px!important}.v-application .ml-lg-n15{margin-left:-60px!important}.v-application .ml-lg-n16{margin-left:-64px!important}.v-application--is-ltr .ms-lg-n1{margin-left:-4px!important}.v-application--is-rtl .ms-lg-n1{margin-right:-4px!important}.v-application--is-ltr .ms-lg-n2{margin-left:-8px!important}.v-application--is-rtl .ms-lg-n2{margin-right:-8px!important}.v-application--is-ltr .ms-lg-n3{margin-left:-12px!important}.v-application--is-rtl .ms-lg-n3{margin-right:-12px!important}.v-application--is-ltr .ms-lg-n4{margin-left:-16px!important}.v-application--is-rtl .ms-lg-n4{margin-right:-16px!important}.v-application--is-ltr .ms-lg-n5{margin-left:-20px!important}.v-application--is-rtl .ms-lg-n5{margin-right:-20px!important}.v-application--is-ltr .ms-lg-n6{margin-left:-24px!important}.v-application--is-rtl .ms-lg-n6{margin-right:-24px!important}.v-application--is-ltr .ms-lg-n7{margin-left:-28px!important}.v-application--is-rtl .ms-lg-n7{margin-right:-28px!important}.v-application--is-ltr .ms-lg-n8{margin-left:-32px!important}.v-application--is-rtl .ms-lg-n8{margin-right:-32px!important}.v-application--is-ltr .ms-lg-n9{margin-left:-36px!important}.v-application--is-rtl .ms-lg-n9{margin-right:-36px!important}.v-application--is-ltr .ms-lg-n10{margin-left:-40px!important}.v-application--is-rtl .ms-lg-n10{margin-right:-40px!important}.v-application--is-ltr .ms-lg-n11{margin-left:-44px!important}.v-application--is-rtl .ms-lg-n11{margin-right:-44px!important}.v-application--is-ltr .ms-lg-n12{margin-left:-48px!important}.v-application--is-rtl .ms-lg-n12{margin-right:-48px!important}.v-application--is-ltr .ms-lg-n13{margin-left:-52px!important}.v-application--is-rtl .ms-lg-n13{margin-right:-52px!important}.v-application--is-ltr .ms-lg-n14{margin-left:-56px!important}.v-application--is-rtl .ms-lg-n14{margin-right:-56px!important}.v-application--is-ltr .ms-lg-n15{margin-left:-60px!important}.v-application--is-rtl .ms-lg-n15{margin-right:-60px!important}.v-application--is-ltr .ms-lg-n16{margin-left:-64px!important}.v-application--is-rtl .ms-lg-n16{margin-right:-64px!important}.v-application--is-ltr .me-lg-n1{margin-right:-4px!important}.v-application--is-rtl .me-lg-n1{margin-left:-4px!important}.v-application--is-ltr .me-lg-n2{margin-right:-8px!important}.v-application--is-rtl .me-lg-n2{margin-left:-8px!important}.v-application--is-ltr .me-lg-n3{margin-right:-12px!important}.v-application--is-rtl .me-lg-n3{margin-left:-12px!important}.v-application--is-ltr .me-lg-n4{margin-right:-16px!important}.v-application--is-rtl .me-lg-n4{margin-left:-16px!important}.v-application--is-ltr .me-lg-n5{margin-right:-20px!important}.v-application--is-rtl .me-lg-n5{margin-left:-20px!important}.v-application--is-ltr .me-lg-n6{margin-right:-24px!important}.v-application--is-rtl .me-lg-n6{margin-left:-24px!important}.v-application--is-ltr .me-lg-n7{margin-right:-28px!important}.v-application--is-rtl .me-lg-n7{margin-left:-28px!important}.v-application--is-ltr .me-lg-n8{margin-right:-32px!important}.v-application--is-rtl .me-lg-n8{margin-left:-32px!important}.v-application--is-ltr .me-lg-n9{margin-right:-36px!important}.v-application--is-rtl .me-lg-n9{margin-left:-36px!important}.v-application--is-ltr .me-lg-n10{margin-right:-40px!important}.v-application--is-rtl .me-lg-n10{margin-left:-40px!important}.v-application--is-ltr .me-lg-n11{margin-right:-44px!important}.v-application--is-rtl .me-lg-n11{margin-left:-44px!important}.v-application--is-ltr .me-lg-n12{margin-right:-48px!important}.v-application--is-rtl .me-lg-n12{margin-left:-48px!important}.v-application--is-ltr .me-lg-n13{margin-right:-52px!important}.v-application--is-rtl .me-lg-n13{margin-left:-52px!important}.v-application--is-ltr .me-lg-n14{margin-right:-56px!important}.v-application--is-rtl .me-lg-n14{margin-left:-56px!important}.v-application--is-ltr .me-lg-n15{margin-right:-60px!important}.v-application--is-rtl .me-lg-n15{margin-left:-60px!important}.v-application--is-ltr .me-lg-n16{margin-right:-64px!important}.v-application--is-rtl .me-lg-n16{margin-left:-64px!important}.v-application .pa-lg-0{padding:0!important}.v-application .pa-lg-1{padding:4px!important}.v-application .pa-lg-2{padding:8px!important}.v-application .pa-lg-3{padding:12px!important}.v-application .pa-lg-4{padding:16px!important}.v-application .pa-lg-5{padding:20px!important}.v-application .pa-lg-6{padding:24px!important}.v-application .pa-lg-7{padding:28px!important}.v-application .pa-lg-8{padding:32px!important}.v-application .pa-lg-9{padding:36px!important}.v-application .pa-lg-10{padding:40px!important}.v-application .pa-lg-11{padding:44px!important}.v-application .pa-lg-12{padding:48px!important}.v-application .pa-lg-13{padding:52px!important}.v-application .pa-lg-14{padding:56px!important}.v-application .pa-lg-15{padding:60px!important}.v-application .pa-lg-16{padding:64px!important}.v-application .px-lg-0{padding-right:0!important;padding-left:0!important}.v-application .px-lg-1{padding-right:4px!important;padding-left:4px!important}.v-application .px-lg-2{padding-right:8px!important;padding-left:8px!important}.v-application .px-lg-3{padding-right:12px!important;padding-left:12px!important}.v-application .px-lg-4{padding-right:16px!important;padding-left:16px!important}.v-application .px-lg-5{padding-right:20px!important;padding-left:20px!important}.v-application .px-lg-6{padding-right:24px!important;padding-left:24px!important}.v-application .px-lg-7{padding-right:28px!important;padding-left:28px!important}.v-application .px-lg-8{padding-right:32px!important;padding-left:32px!important}.v-application .px-lg-9{padding-right:36px!important;padding-left:36px!important}.v-application .px-lg-10{padding-right:40px!important;padding-left:40px!important}.v-application .px-lg-11{padding-right:44px!important;padding-left:44px!important}.v-application .px-lg-12{padding-right:48px!important;padding-left:48px!important}.v-application .px-lg-13{padding-right:52px!important;padding-left:52px!important}.v-application .px-lg-14{padding-right:56px!important;padding-left:56px!important}.v-application .px-lg-15{padding-right:60px!important;padding-left:60px!important}.v-application .px-lg-16{padding-right:64px!important;padding-left:64px!important}.v-application .py-lg-0{padding-top:0!important;padding-bottom:0!important}.v-application .py-lg-1{padding-top:4px!important;padding-bottom:4px!important}.v-application .py-lg-2{padding-top:8px!important;padding-bottom:8px!important}.v-application .py-lg-3{padding-top:12px!important;padding-bottom:12px!important}.v-application .py-lg-4{padding-top:16px!important;padding-bottom:16px!important}.v-application .py-lg-5{padding-top:20px!important;padding-bottom:20px!important}.v-application .py-lg-6{padding-top:24px!important;padding-bottom:24px!important}.v-application .py-lg-7{padding-top:28px!important;padding-bottom:28px!important}.v-application .py-lg-8{padding-top:32px!important;padding-bottom:32px!important}.v-application .py-lg-9{padding-top:36px!important;padding-bottom:36px!important}.v-application .py-lg-10{padding-top:40px!important;padding-bottom:40px!important}.v-application .py-lg-11{padding-top:44px!important;padding-bottom:44px!important}.v-application .py-lg-12{padding-top:48px!important;padding-bottom:48px!important}.v-application .py-lg-13{padding-top:52px!important;padding-bottom:52px!important}.v-application .py-lg-14{padding-top:56px!important;padding-bottom:56px!important}.v-application .py-lg-15{padding-top:60px!important;padding-bottom:60px!important}.v-application .py-lg-16{padding-top:64px!important;padding-bottom:64px!important}.v-application .pt-lg-0{padding-top:0!important}.v-application .pt-lg-1{padding-top:4px!important}.v-application .pt-lg-2{padding-top:8px!important}.v-application .pt-lg-3{padding-top:12px!important}.v-application .pt-lg-4{padding-top:16px!important}.v-application .pt-lg-5{padding-top:20px!important}.v-application .pt-lg-6{padding-top:24px!important}.v-application .pt-lg-7{padding-top:28px!important}.v-application .pt-lg-8{padding-top:32px!important}.v-application .pt-lg-9{padding-top:36px!important}.v-application .pt-lg-10{padding-top:40px!important}.v-application .pt-lg-11{padding-top:44px!important}.v-application .pt-lg-12{padding-top:48px!important}.v-application .pt-lg-13{padding-top:52px!important}.v-application .pt-lg-14{padding-top:56px!important}.v-application .pt-lg-15{padding-top:60px!important}.v-application .pt-lg-16{padding-top:64px!important}.v-application .pr-lg-0{padding-right:0!important}.v-application .pr-lg-1{padding-right:4px!important}.v-application .pr-lg-2{padding-right:8px!important}.v-application .pr-lg-3{padding-right:12px!important}.v-application .pr-lg-4{padding-right:16px!important}.v-application .pr-lg-5{padding-right:20px!important}.v-application .pr-lg-6{padding-right:24px!important}.v-application .pr-lg-7{padding-right:28px!important}.v-application .pr-lg-8{padding-right:32px!important}.v-application .pr-lg-9{padding-right:36px!important}.v-application .pr-lg-10{padding-right:40px!important}.v-application .pr-lg-11{padding-right:44px!important}.v-application .pr-lg-12{padding-right:48px!important}.v-application .pr-lg-13{padding-right:52px!important}.v-application .pr-lg-14{padding-right:56px!important}.v-application .pr-lg-15{padding-right:60px!important}.v-application .pr-lg-16{padding-right:64px!important}.v-application .pb-lg-0{padding-bottom:0!important}.v-application .pb-lg-1{padding-bottom:4px!important}.v-application .pb-lg-2{padding-bottom:8px!important}.v-application .pb-lg-3{padding-bottom:12px!important}.v-application .pb-lg-4{padding-bottom:16px!important}.v-application .pb-lg-5{padding-bottom:20px!important}.v-application .pb-lg-6{padding-bottom:24px!important}.v-application .pb-lg-7{padding-bottom:28px!important}.v-application .pb-lg-8{padding-bottom:32px!important}.v-application .pb-lg-9{padding-bottom:36px!important}.v-application .pb-lg-10{padding-bottom:40px!important}.v-application .pb-lg-11{padding-bottom:44px!important}.v-application .pb-lg-12{padding-bottom:48px!important}.v-application .pb-lg-13{padding-bottom:52px!important}.v-application .pb-lg-14{padding-bottom:56px!important}.v-application .pb-lg-15{padding-bottom:60px!important}.v-application .pb-lg-16{padding-bottom:64px!important}.v-application .pl-lg-0{padding-left:0!important}.v-application .pl-lg-1{padding-left:4px!important}.v-application .pl-lg-2{padding-left:8px!important}.v-application .pl-lg-3{padding-left:12px!important}.v-application .pl-lg-4{padding-left:16px!important}.v-application .pl-lg-5{padding-left:20px!important}.v-application .pl-lg-6{padding-left:24px!important}.v-application .pl-lg-7{padding-left:28px!important}.v-application .pl-lg-8{padding-left:32px!important}.v-application .pl-lg-9{padding-left:36px!important}.v-application .pl-lg-10{padding-left:40px!important}.v-application .pl-lg-11{padding-left:44px!important}.v-application .pl-lg-12{padding-left:48px!important}.v-application .pl-lg-13{padding-left:52px!important}.v-application .pl-lg-14{padding-left:56px!important}.v-application .pl-lg-15{padding-left:60px!important}.v-application .pl-lg-16{padding-left:64px!important}.v-application--is-ltr .ps-lg-0{padding-left:0!important}.v-application--is-rtl .ps-lg-0{padding-right:0!important}.v-application--is-ltr .ps-lg-1{padding-left:4px!important}.v-application--is-rtl .ps-lg-1{padding-right:4px!important}.v-application--is-ltr .ps-lg-2{padding-left:8px!important}.v-application--is-rtl .ps-lg-2{padding-right:8px!important}.v-application--is-ltr .ps-lg-3{padding-left:12px!important}.v-application--is-rtl .ps-lg-3{padding-right:12px!important}.v-application--is-ltr .ps-lg-4{padding-left:16px!important}.v-application--is-rtl .ps-lg-4{padding-right:16px!important}.v-application--is-ltr .ps-lg-5{padding-left:20px!important}.v-application--is-rtl .ps-lg-5{padding-right:20px!important}.v-application--is-ltr .ps-lg-6{padding-left:24px!important}.v-application--is-rtl .ps-lg-6{padding-right:24px!important}.v-application--is-ltr .ps-lg-7{padding-left:28px!important}.v-application--is-rtl .ps-lg-7{padding-right:28px!important}.v-application--is-ltr .ps-lg-8{padding-left:32px!important}.v-application--is-rtl .ps-lg-8{padding-right:32px!important}.v-application--is-ltr .ps-lg-9{padding-left:36px!important}.v-application--is-rtl .ps-lg-9{padding-right:36px!important}.v-application--is-ltr .ps-lg-10{padding-left:40px!important}.v-application--is-rtl .ps-lg-10{padding-right:40px!important}.v-application--is-ltr .ps-lg-11{padding-left:44px!important}.v-application--is-rtl .ps-lg-11{padding-right:44px!important}.v-application--is-ltr .ps-lg-12{padding-left:48px!important}.v-application--is-rtl .ps-lg-12{padding-right:48px!important}.v-application--is-ltr .ps-lg-13{padding-left:52px!important}.v-application--is-rtl .ps-lg-13{padding-right:52px!important}.v-application--is-ltr .ps-lg-14{padding-left:56px!important}.v-application--is-rtl .ps-lg-14{padding-right:56px!important}.v-application--is-ltr .ps-lg-15{padding-left:60px!important}.v-application--is-rtl .ps-lg-15{padding-right:60px!important}.v-application--is-ltr .ps-lg-16{padding-left:64px!important}.v-application--is-rtl .ps-lg-16{padding-right:64px!important}.v-application--is-ltr .pe-lg-0{padding-right:0!important}.v-application--is-rtl .pe-lg-0{padding-left:0!important}.v-application--is-ltr .pe-lg-1{padding-right:4px!important}.v-application--is-rtl .pe-lg-1{padding-left:4px!important}.v-application--is-ltr .pe-lg-2{padding-right:8px!important}.v-application--is-rtl .pe-lg-2{padding-left:8px!important}.v-application--is-ltr .pe-lg-3{padding-right:12px!important}.v-application--is-rtl .pe-lg-3{padding-left:12px!important}.v-application--is-ltr .pe-lg-4{padding-right:16px!important}.v-application--is-rtl .pe-lg-4{padding-left:16px!important}.v-application--is-ltr .pe-lg-5{padding-right:20px!important}.v-application--is-rtl .pe-lg-5{padding-left:20px!important}.v-application--is-ltr .pe-lg-6{padding-right:24px!important}.v-application--is-rtl .pe-lg-6{padding-left:24px!important}.v-application--is-ltr .pe-lg-7{padding-right:28px!important}.v-application--is-rtl .pe-lg-7{padding-left:28px!important}.v-application--is-ltr .pe-lg-8{padding-right:32px!important}.v-application--is-rtl .pe-lg-8{padding-left:32px!important}.v-application--is-ltr .pe-lg-9{padding-right:36px!important}.v-application--is-rtl .pe-lg-9{padding-left:36px!important}.v-application--is-ltr .pe-lg-10{padding-right:40px!important}.v-application--is-rtl .pe-lg-10{padding-left:40px!important}.v-application--is-ltr .pe-lg-11{padding-right:44px!important}.v-application--is-rtl .pe-lg-11{padding-left:44px!important}.v-application--is-ltr .pe-lg-12{padding-right:48px!important}.v-application--is-rtl .pe-lg-12{padding-left:48px!important}.v-application--is-ltr .pe-lg-13{padding-right:52px!important}.v-application--is-rtl .pe-lg-13{padding-left:52px!important}.v-application--is-ltr .pe-lg-14{padding-right:56px!important}.v-application--is-rtl .pe-lg-14{padding-left:56px!important}.v-application--is-ltr .pe-lg-15{padding-right:60px!important}.v-application--is-rtl .pe-lg-15{padding-left:60px!important}.v-application--is-ltr .pe-lg-16{padding-right:64px!important}.v-application--is-rtl .pe-lg-16{padding-left:64px!important}.v-application .text-lg-left{text-align:left!important}.v-application .text-lg-right{text-align:right!important}.v-application .text-lg-center{text-align:center!important}.v-application .text-lg-justify{text-align:justify!important}.v-application .text-lg-start{text-align:start!important}.v-application .text-lg-end{text-align:end!important}.v-application .text-lg-h1{font-size:6rem!important;line-height:6rem;letter-spacing:-.015625em!important}.v-application .text-lg-h1,.v-application .text-lg-h2{font-weight:300;font-family:Roboto,sans-serif!important}.v-application .text-lg-h2{font-size:3.75rem!important;line-height:3.75rem;letter-spacing:-.0083333333em!important}.v-application .text-lg-h3{font-size:3rem!important;line-height:3.125rem;letter-spacing:normal!important}.v-application .text-lg-h3,.v-application .text-lg-h4{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .text-lg-h4{font-size:2.125rem!important;line-height:2.5rem;letter-spacing:.0073529412em!important}.v-application .text-lg-h5{font-size:1.5rem!important;font-weight:400;letter-spacing:normal!important}.v-application .text-lg-h5,.v-application .text-lg-h6{line-height:2rem;font-family:Roboto,sans-serif!important}.v-application .text-lg-h6{font-size:1.25rem!important;font-weight:500;letter-spacing:.0125em!important}.v-application .text-lg-subtitle-1{font-size:1rem!important;font-weight:400;line-height:1.75rem;letter-spacing:.009375em!important;font-family:Roboto,sans-serif!important}.v-application .text-lg-subtitle-2{font-size:.875rem!important;font-weight:500;line-height:1.375rem;letter-spacing:.0071428571em!important;font-family:Roboto,sans-serif!important}.v-application .text-lg-body-1{font-size:1rem!important;font-weight:400;line-height:1.5rem;letter-spacing:.03125em!important;font-family:Roboto,sans-serif!important}.v-application .text-lg-body-2{font-weight:400;line-height:1.25rem;letter-spacing:.0178571429em!important}.v-application .text-lg-body-2,.v-application .text-lg-button{font-size:.875rem!important;font-family:Roboto,sans-serif!important}.v-application .text-lg-button{font-weight:500;line-height:2.25rem;letter-spacing:.0892857143em!important;text-transform:uppercase!important}.v-application .text-lg-caption{font-weight:400;line-height:1.25rem;letter-spacing:.0333333333em!important}.v-application .text-lg-caption,.v-application .text-lg-overline{font-size:.75rem!important;font-family:Roboto,sans-serif!important}.v-application .text-lg-overline{font-weight:500;line-height:2rem;letter-spacing:.1666666667em!important;text-transform:uppercase!important}}@media(min-width:1904px){.v-application .d-xl-none{display:none!important}.v-application .d-xl-inline{display:inline!important}.v-application .d-xl-inline-block{display:inline-block!important}.v-application .d-xl-block{display:block!important}.v-application .d-xl-table{display:table!important}.v-application .d-xl-table-row{display:table-row!important}.v-application .d-xl-table-cell{display:table-cell!important}.v-application .d-xl-flex{display:flex!important}.v-application .d-xl-inline-flex{display:inline-flex!important}.v-application .float-xl-none{float:none!important}.v-application .float-xl-left{float:left!important}.v-application .float-xl-right{float:right!important}.v-application--is-rtl .float-xl-end{float:left!important}.v-application--is-ltr .float-xl-end,.v-application--is-rtl .float-xl-start{float:right!important}.v-application--is-ltr .float-xl-start{float:left!important}.v-application .flex-xl-fill{flex:1 1 auto!important}.v-application .flex-xl-row{flex-direction:row!important}.v-application .flex-xl-column{flex-direction:column!important}.v-application .flex-xl-row-reverse{flex-direction:row-reverse!important}.v-application .flex-xl-column-reverse{flex-direction:column-reverse!important}.v-application .flex-xl-grow-0{flex-grow:0!important}.v-application .flex-xl-grow-1{flex-grow:1!important}.v-application .flex-xl-shrink-0{flex-shrink:0!important}.v-application .flex-xl-shrink-1{flex-shrink:1!important}.v-application .flex-xl-wrap{flex-wrap:wrap!important}.v-application .flex-xl-nowrap{flex-wrap:nowrap!important}.v-application .flex-xl-wrap-reverse{flex-wrap:wrap-reverse!important}.v-application .justify-xl-start{justify-content:flex-start!important}.v-application .justify-xl-end{justify-content:flex-end!important}.v-application .justify-xl-center{justify-content:center!important}.v-application .justify-xl-space-between{justify-content:space-between!important}.v-application .justify-xl-space-around{justify-content:space-around!important}.v-application .align-xl-start{align-items:flex-start!important}.v-application .align-xl-end{align-items:flex-end!important}.v-application .align-xl-center{align-items:center!important}.v-application .align-xl-baseline{align-items:baseline!important}.v-application .align-xl-stretch{align-items:stretch!important}.v-application .align-content-xl-start{align-content:flex-start!important}.v-application .align-content-xl-end{align-content:flex-end!important}.v-application .align-content-xl-center{align-content:center!important}.v-application .align-content-xl-space-between{align-content:space-between!important}.v-application .align-content-xl-space-around{align-content:space-around!important}.v-application .align-content-xl-stretch{align-content:stretch!important}.v-application .align-self-xl-auto{align-self:auto!important}.v-application .align-self-xl-start{align-self:flex-start!important}.v-application .align-self-xl-end{align-self:flex-end!important}.v-application .align-self-xl-center{align-self:center!important}.v-application .align-self-xl-baseline{align-self:baseline!important}.v-application .align-self-xl-stretch{align-self:stretch!important}.v-application .order-xl-first{order:-1!important}.v-application .order-xl-0{order:0!important}.v-application .order-xl-1{order:1!important}.v-application .order-xl-2{order:2!important}.v-application .order-xl-3{order:3!important}.v-application .order-xl-4{order:4!important}.v-application .order-xl-5{order:5!important}.v-application .order-xl-6{order:6!important}.v-application .order-xl-7{order:7!important}.v-application .order-xl-8{order:8!important}.v-application .order-xl-9{order:9!important}.v-application .order-xl-10{order:10!important}.v-application .order-xl-11{order:11!important}.v-application .order-xl-12{order:12!important}.v-application .order-xl-last{order:13!important}.v-application .ma-xl-0{margin:0!important}.v-application .ma-xl-1{margin:4px!important}.v-application .ma-xl-2{margin:8px!important}.v-application .ma-xl-3{margin:12px!important}.v-application .ma-xl-4{margin:16px!important}.v-application .ma-xl-5{margin:20px!important}.v-application .ma-xl-6{margin:24px!important}.v-application .ma-xl-7{margin:28px!important}.v-application .ma-xl-8{margin:32px!important}.v-application .ma-xl-9{margin:36px!important}.v-application .ma-xl-10{margin:40px!important}.v-application .ma-xl-11{margin:44px!important}.v-application .ma-xl-12{margin:48px!important}.v-application .ma-xl-13{margin:52px!important}.v-application .ma-xl-14{margin:56px!important}.v-application .ma-xl-15{margin:60px!important}.v-application .ma-xl-16{margin:64px!important}.v-application .ma-xl-auto{margin:auto!important}.v-application .mx-xl-0{margin-right:0!important;margin-left:0!important}.v-application .mx-xl-1{margin-right:4px!important;margin-left:4px!important}.v-application .mx-xl-2{margin-right:8px!important;margin-left:8px!important}.v-application .mx-xl-3{margin-right:12px!important;margin-left:12px!important}.v-application .mx-xl-4{margin-right:16px!important;margin-left:16px!important}.v-application .mx-xl-5{margin-right:20px!important;margin-left:20px!important}.v-application .mx-xl-6{margin-right:24px!important;margin-left:24px!important}.v-application .mx-xl-7{margin-right:28px!important;margin-left:28px!important}.v-application .mx-xl-8{margin-right:32px!important;margin-left:32px!important}.v-application .mx-xl-9{margin-right:36px!important;margin-left:36px!important}.v-application .mx-xl-10{margin-right:40px!important;margin-left:40px!important}.v-application .mx-xl-11{margin-right:44px!important;margin-left:44px!important}.v-application .mx-xl-12{margin-right:48px!important;margin-left:48px!important}.v-application .mx-xl-13{margin-right:52px!important;margin-left:52px!important}.v-application .mx-xl-14{margin-right:56px!important;margin-left:56px!important}.v-application .mx-xl-15{margin-right:60px!important;margin-left:60px!important}.v-application .mx-xl-16{margin-right:64px!important;margin-left:64px!important}.v-application .mx-xl-auto{margin-right:auto!important;margin-left:auto!important}.v-application .my-xl-0{margin-top:0!important;margin-bottom:0!important}.v-application .my-xl-1{margin-top:4px!important;margin-bottom:4px!important}.v-application .my-xl-2{margin-top:8px!important;margin-bottom:8px!important}.v-application .my-xl-3{margin-top:12px!important;margin-bottom:12px!important}.v-application .my-xl-4{margin-top:16px!important;margin-bottom:16px!important}.v-application .my-xl-5{margin-top:20px!important;margin-bottom:20px!important}.v-application .my-xl-6{margin-top:24px!important;margin-bottom:24px!important}.v-application .my-xl-7{margin-top:28px!important;margin-bottom:28px!important}.v-application .my-xl-8{margin-top:32px!important;margin-bottom:32px!important}.v-application .my-xl-9{margin-top:36px!important;margin-bottom:36px!important}.v-application .my-xl-10{margin-top:40px!important;margin-bottom:40px!important}.v-application .my-xl-11{margin-top:44px!important;margin-bottom:44px!important}.v-application .my-xl-12{margin-top:48px!important;margin-bottom:48px!important}.v-application .my-xl-13{margin-top:52px!important;margin-bottom:52px!important}.v-application .my-xl-14{margin-top:56px!important;margin-bottom:56px!important}.v-application .my-xl-15{margin-top:60px!important;margin-bottom:60px!important}.v-application .my-xl-16{margin-top:64px!important;margin-bottom:64px!important}.v-application .my-xl-auto{margin-top:auto!important;margin-bottom:auto!important}.v-application .mt-xl-0{margin-top:0!important}.v-application .mt-xl-1{margin-top:4px!important}.v-application .mt-xl-2{margin-top:8px!important}.v-application .mt-xl-3{margin-top:12px!important}.v-application .mt-xl-4{margin-top:16px!important}.v-application .mt-xl-5{margin-top:20px!important}.v-application .mt-xl-6{margin-top:24px!important}.v-application .mt-xl-7{margin-top:28px!important}.v-application .mt-xl-8{margin-top:32px!important}.v-application .mt-xl-9{margin-top:36px!important}.v-application .mt-xl-10{margin-top:40px!important}.v-application .mt-xl-11{margin-top:44px!important}.v-application .mt-xl-12{margin-top:48px!important}.v-application .mt-xl-13{margin-top:52px!important}.v-application .mt-xl-14{margin-top:56px!important}.v-application .mt-xl-15{margin-top:60px!important}.v-application .mt-xl-16{margin-top:64px!important}.v-application .mt-xl-auto{margin-top:auto!important}.v-application .mr-xl-0{margin-right:0!important}.v-application .mr-xl-1{margin-right:4px!important}.v-application .mr-xl-2{margin-right:8px!important}.v-application .mr-xl-3{margin-right:12px!important}.v-application .mr-xl-4{margin-right:16px!important}.v-application .mr-xl-5{margin-right:20px!important}.v-application .mr-xl-6{margin-right:24px!important}.v-application .mr-xl-7{margin-right:28px!important}.v-application .mr-xl-8{margin-right:32px!important}.v-application .mr-xl-9{margin-right:36px!important}.v-application .mr-xl-10{margin-right:40px!important}.v-application .mr-xl-11{margin-right:44px!important}.v-application .mr-xl-12{margin-right:48px!important}.v-application .mr-xl-13{margin-right:52px!important}.v-application .mr-xl-14{margin-right:56px!important}.v-application .mr-xl-15{margin-right:60px!important}.v-application .mr-xl-16{margin-right:64px!important}.v-application .mr-xl-auto{margin-right:auto!important}.v-application .mb-xl-0{margin-bottom:0!important}.v-application .mb-xl-1{margin-bottom:4px!important}.v-application .mb-xl-2{margin-bottom:8px!important}.v-application .mb-xl-3{margin-bottom:12px!important}.v-application .mb-xl-4{margin-bottom:16px!important}.v-application .mb-xl-5{margin-bottom:20px!important}.v-application .mb-xl-6{margin-bottom:24px!important}.v-application .mb-xl-7{margin-bottom:28px!important}.v-application .mb-xl-8{margin-bottom:32px!important}.v-application .mb-xl-9{margin-bottom:36px!important}.v-application .mb-xl-10{margin-bottom:40px!important}.v-application .mb-xl-11{margin-bottom:44px!important}.v-application .mb-xl-12{margin-bottom:48px!important}.v-application .mb-xl-13{margin-bottom:52px!important}.v-application .mb-xl-14{margin-bottom:56px!important}.v-application .mb-xl-15{margin-bottom:60px!important}.v-application .mb-xl-16{margin-bottom:64px!important}.v-application .mb-xl-auto{margin-bottom:auto!important}.v-application .ml-xl-0{margin-left:0!important}.v-application .ml-xl-1{margin-left:4px!important}.v-application .ml-xl-2{margin-left:8px!important}.v-application .ml-xl-3{margin-left:12px!important}.v-application .ml-xl-4{margin-left:16px!important}.v-application .ml-xl-5{margin-left:20px!important}.v-application .ml-xl-6{margin-left:24px!important}.v-application .ml-xl-7{margin-left:28px!important}.v-application .ml-xl-8{margin-left:32px!important}.v-application .ml-xl-9{margin-left:36px!important}.v-application .ml-xl-10{margin-left:40px!important}.v-application .ml-xl-11{margin-left:44px!important}.v-application .ml-xl-12{margin-left:48px!important}.v-application .ml-xl-13{margin-left:52px!important}.v-application .ml-xl-14{margin-left:56px!important}.v-application .ml-xl-15{margin-left:60px!important}.v-application .ml-xl-16{margin-left:64px!important}.v-application .ml-xl-auto{margin-left:auto!important}.v-application--is-ltr .ms-xl-0{margin-left:0!important}.v-application--is-rtl .ms-xl-0{margin-right:0!important}.v-application--is-ltr .ms-xl-1{margin-left:4px!important}.v-application--is-rtl .ms-xl-1{margin-right:4px!important}.v-application--is-ltr .ms-xl-2{margin-left:8px!important}.v-application--is-rtl .ms-xl-2{margin-right:8px!important}.v-application--is-ltr .ms-xl-3{margin-left:12px!important}.v-application--is-rtl .ms-xl-3{margin-right:12px!important}.v-application--is-ltr .ms-xl-4{margin-left:16px!important}.v-application--is-rtl .ms-xl-4{margin-right:16px!important}.v-application--is-ltr .ms-xl-5{margin-left:20px!important}.v-application--is-rtl .ms-xl-5{margin-right:20px!important}.v-application--is-ltr .ms-xl-6{margin-left:24px!important}.v-application--is-rtl .ms-xl-6{margin-right:24px!important}.v-application--is-ltr .ms-xl-7{margin-left:28px!important}.v-application--is-rtl .ms-xl-7{margin-right:28px!important}.v-application--is-ltr .ms-xl-8{margin-left:32px!important}.v-application--is-rtl .ms-xl-8{margin-right:32px!important}.v-application--is-ltr .ms-xl-9{margin-left:36px!important}.v-application--is-rtl .ms-xl-9{margin-right:36px!important}.v-application--is-ltr .ms-xl-10{margin-left:40px!important}.v-application--is-rtl .ms-xl-10{margin-right:40px!important}.v-application--is-ltr .ms-xl-11{margin-left:44px!important}.v-application--is-rtl .ms-xl-11{margin-right:44px!important}.v-application--is-ltr .ms-xl-12{margin-left:48px!important}.v-application--is-rtl .ms-xl-12{margin-right:48px!important}.v-application--is-ltr .ms-xl-13{margin-left:52px!important}.v-application--is-rtl .ms-xl-13{margin-right:52px!important}.v-application--is-ltr .ms-xl-14{margin-left:56px!important}.v-application--is-rtl .ms-xl-14{margin-right:56px!important}.v-application--is-ltr .ms-xl-15{margin-left:60px!important}.v-application--is-rtl .ms-xl-15{margin-right:60px!important}.v-application--is-ltr .ms-xl-16{margin-left:64px!important}.v-application--is-rtl .ms-xl-16{margin-right:64px!important}.v-application--is-ltr .ms-xl-auto{margin-left:auto!important}.v-application--is-rtl .ms-xl-auto{margin-right:auto!important}.v-application--is-ltr .me-xl-0{margin-right:0!important}.v-application--is-rtl .me-xl-0{margin-left:0!important}.v-application--is-ltr .me-xl-1{margin-right:4px!important}.v-application--is-rtl .me-xl-1{margin-left:4px!important}.v-application--is-ltr .me-xl-2{margin-right:8px!important}.v-application--is-rtl .me-xl-2{margin-left:8px!important}.v-application--is-ltr .me-xl-3{margin-right:12px!important}.v-application--is-rtl .me-xl-3{margin-left:12px!important}.v-application--is-ltr .me-xl-4{margin-right:16px!important}.v-application--is-rtl .me-xl-4{margin-left:16px!important}.v-application--is-ltr .me-xl-5{margin-right:20px!important}.v-application--is-rtl .me-xl-5{margin-left:20px!important}.v-application--is-ltr .me-xl-6{margin-right:24px!important}.v-application--is-rtl .me-xl-6{margin-left:24px!important}.v-application--is-ltr .me-xl-7{margin-right:28px!important}.v-application--is-rtl .me-xl-7{margin-left:28px!important}.v-application--is-ltr .me-xl-8{margin-right:32px!important}.v-application--is-rtl .me-xl-8{margin-left:32px!important}.v-application--is-ltr .me-xl-9{margin-right:36px!important}.v-application--is-rtl .me-xl-9{margin-left:36px!important}.v-application--is-ltr .me-xl-10{margin-right:40px!important}.v-application--is-rtl .me-xl-10{margin-left:40px!important}.v-application--is-ltr .me-xl-11{margin-right:44px!important}.v-application--is-rtl .me-xl-11{margin-left:44px!important}.v-application--is-ltr .me-xl-12{margin-right:48px!important}.v-application--is-rtl .me-xl-12{margin-left:48px!important}.v-application--is-ltr .me-xl-13{margin-right:52px!important}.v-application--is-rtl .me-xl-13{margin-left:52px!important}.v-application--is-ltr .me-xl-14{margin-right:56px!important}.v-application--is-rtl .me-xl-14{margin-left:56px!important}.v-application--is-ltr .me-xl-15{margin-right:60px!important}.v-application--is-rtl .me-xl-15{margin-left:60px!important}.v-application--is-ltr .me-xl-16{margin-right:64px!important}.v-application--is-rtl .me-xl-16{margin-left:64px!important}.v-application--is-ltr .me-xl-auto{margin-right:auto!important}.v-application--is-rtl .me-xl-auto{margin-left:auto!important}.v-application .ma-xl-n1{margin:-4px!important}.v-application .ma-xl-n2{margin:-8px!important}.v-application .ma-xl-n3{margin:-12px!important}.v-application .ma-xl-n4{margin:-16px!important}.v-application .ma-xl-n5{margin:-20px!important}.v-application .ma-xl-n6{margin:-24px!important}.v-application .ma-xl-n7{margin:-28px!important}.v-application .ma-xl-n8{margin:-32px!important}.v-application .ma-xl-n9{margin:-36px!important}.v-application .ma-xl-n10{margin:-40px!important}.v-application .ma-xl-n11{margin:-44px!important}.v-application .ma-xl-n12{margin:-48px!important}.v-application .ma-xl-n13{margin:-52px!important}.v-application .ma-xl-n14{margin:-56px!important}.v-application .ma-xl-n15{margin:-60px!important}.v-application .ma-xl-n16{margin:-64px!important}.v-application .mx-xl-n1{margin-right:-4px!important;margin-left:-4px!important}.v-application .mx-xl-n2{margin-right:-8px!important;margin-left:-8px!important}.v-application .mx-xl-n3{margin-right:-12px!important;margin-left:-12px!important}.v-application .mx-xl-n4{margin-right:-16px!important;margin-left:-16px!important}.v-application .mx-xl-n5{margin-right:-20px!important;margin-left:-20px!important}.v-application .mx-xl-n6{margin-right:-24px!important;margin-left:-24px!important}.v-application .mx-xl-n7{margin-right:-28px!important;margin-left:-28px!important}.v-application .mx-xl-n8{margin-right:-32px!important;margin-left:-32px!important}.v-application .mx-xl-n9{margin-right:-36px!important;margin-left:-36px!important}.v-application .mx-xl-n10{margin-right:-40px!important;margin-left:-40px!important}.v-application .mx-xl-n11{margin-right:-44px!important;margin-left:-44px!important}.v-application .mx-xl-n12{margin-right:-48px!important;margin-left:-48px!important}.v-application .mx-xl-n13{margin-right:-52px!important;margin-left:-52px!important}.v-application .mx-xl-n14{margin-right:-56px!important;margin-left:-56px!important}.v-application .mx-xl-n15{margin-right:-60px!important;margin-left:-60px!important}.v-application .mx-xl-n16{margin-right:-64px!important;margin-left:-64px!important}.v-application .my-xl-n1{margin-top:-4px!important;margin-bottom:-4px!important}.v-application .my-xl-n2{margin-top:-8px!important;margin-bottom:-8px!important}.v-application .my-xl-n3{margin-top:-12px!important;margin-bottom:-12px!important}.v-application .my-xl-n4{margin-top:-16px!important;margin-bottom:-16px!important}.v-application .my-xl-n5{margin-top:-20px!important;margin-bottom:-20px!important}.v-application .my-xl-n6{margin-top:-24px!important;margin-bottom:-24px!important}.v-application .my-xl-n7{margin-top:-28px!important;margin-bottom:-28px!important}.v-application .my-xl-n8{margin-top:-32px!important;margin-bottom:-32px!important}.v-application .my-xl-n9{margin-top:-36px!important;margin-bottom:-36px!important}.v-application .my-xl-n10{margin-top:-40px!important;margin-bottom:-40px!important}.v-application .my-xl-n11{margin-top:-44px!important;margin-bottom:-44px!important}.v-application .my-xl-n12{margin-top:-48px!important;margin-bottom:-48px!important}.v-application .my-xl-n13{margin-top:-52px!important;margin-bottom:-52px!important}.v-application .my-xl-n14{margin-top:-56px!important;margin-bottom:-56px!important}.v-application .my-xl-n15{margin-top:-60px!important;margin-bottom:-60px!important}.v-application .my-xl-n16{margin-top:-64px!important;margin-bottom:-64px!important}.v-application .mt-xl-n1{margin-top:-4px!important}.v-application .mt-xl-n2{margin-top:-8px!important}.v-application .mt-xl-n3{margin-top:-12px!important}.v-application .mt-xl-n4{margin-top:-16px!important}.v-application .mt-xl-n5{margin-top:-20px!important}.v-application .mt-xl-n6{margin-top:-24px!important}.v-application .mt-xl-n7{margin-top:-28px!important}.v-application .mt-xl-n8{margin-top:-32px!important}.v-application .mt-xl-n9{margin-top:-36px!important}.v-application .mt-xl-n10{margin-top:-40px!important}.v-application .mt-xl-n11{margin-top:-44px!important}.v-application .mt-xl-n12{margin-top:-48px!important}.v-application .mt-xl-n13{margin-top:-52px!important}.v-application .mt-xl-n14{margin-top:-56px!important}.v-application .mt-xl-n15{margin-top:-60px!important}.v-application .mt-xl-n16{margin-top:-64px!important}.v-application .mr-xl-n1{margin-right:-4px!important}.v-application .mr-xl-n2{margin-right:-8px!important}.v-application .mr-xl-n3{margin-right:-12px!important}.v-application .mr-xl-n4{margin-right:-16px!important}.v-application .mr-xl-n5{margin-right:-20px!important}.v-application .mr-xl-n6{margin-right:-24px!important}.v-application .mr-xl-n7{margin-right:-28px!important}.v-application .mr-xl-n8{margin-right:-32px!important}.v-application .mr-xl-n9{margin-right:-36px!important}.v-application .mr-xl-n10{margin-right:-40px!important}.v-application .mr-xl-n11{margin-right:-44px!important}.v-application .mr-xl-n12{margin-right:-48px!important}.v-application .mr-xl-n13{margin-right:-52px!important}.v-application .mr-xl-n14{margin-right:-56px!important}.v-application .mr-xl-n15{margin-right:-60px!important}.v-application .mr-xl-n16{margin-right:-64px!important}.v-application .mb-xl-n1{margin-bottom:-4px!important}.v-application .mb-xl-n2{margin-bottom:-8px!important}.v-application .mb-xl-n3{margin-bottom:-12px!important}.v-application .mb-xl-n4{margin-bottom:-16px!important}.v-application .mb-xl-n5{margin-bottom:-20px!important}.v-application .mb-xl-n6{margin-bottom:-24px!important}.v-application .mb-xl-n7{margin-bottom:-28px!important}.v-application .mb-xl-n8{margin-bottom:-32px!important}.v-application .mb-xl-n9{margin-bottom:-36px!important}.v-application .mb-xl-n10{margin-bottom:-40px!important}.v-application .mb-xl-n11{margin-bottom:-44px!important}.v-application .mb-xl-n12{margin-bottom:-48px!important}.v-application .mb-xl-n13{margin-bottom:-52px!important}.v-application .mb-xl-n14{margin-bottom:-56px!important}.v-application .mb-xl-n15{margin-bottom:-60px!important}.v-application .mb-xl-n16{margin-bottom:-64px!important}.v-application .ml-xl-n1{margin-left:-4px!important}.v-application .ml-xl-n2{margin-left:-8px!important}.v-application .ml-xl-n3{margin-left:-12px!important}.v-application .ml-xl-n4{margin-left:-16px!important}.v-application .ml-xl-n5{margin-left:-20px!important}.v-application .ml-xl-n6{margin-left:-24px!important}.v-application .ml-xl-n7{margin-left:-28px!important}.v-application .ml-xl-n8{margin-left:-32px!important}.v-application .ml-xl-n9{margin-left:-36px!important}.v-application .ml-xl-n10{margin-left:-40px!important}.v-application .ml-xl-n11{margin-left:-44px!important}.v-application .ml-xl-n12{margin-left:-48px!important}.v-application .ml-xl-n13{margin-left:-52px!important}.v-application .ml-xl-n14{margin-left:-56px!important}.v-application .ml-xl-n15{margin-left:-60px!important}.v-application .ml-xl-n16{margin-left:-64px!important}.v-application--is-ltr .ms-xl-n1{margin-left:-4px!important}.v-application--is-rtl .ms-xl-n1{margin-right:-4px!important}.v-application--is-ltr .ms-xl-n2{margin-left:-8px!important}.v-application--is-rtl .ms-xl-n2{margin-right:-8px!important}.v-application--is-ltr .ms-xl-n3{margin-left:-12px!important}.v-application--is-rtl .ms-xl-n3{margin-right:-12px!important}.v-application--is-ltr .ms-xl-n4{margin-left:-16px!important}.v-application--is-rtl .ms-xl-n4{margin-right:-16px!important}.v-application--is-ltr .ms-xl-n5{margin-left:-20px!important}.v-application--is-rtl .ms-xl-n5{margin-right:-20px!important}.v-application--is-ltr .ms-xl-n6{margin-left:-24px!important}.v-application--is-rtl .ms-xl-n6{margin-right:-24px!important}.v-application--is-ltr .ms-xl-n7{margin-left:-28px!important}.v-application--is-rtl .ms-xl-n7{margin-right:-28px!important}.v-application--is-ltr .ms-xl-n8{margin-left:-32px!important}.v-application--is-rtl .ms-xl-n8{margin-right:-32px!important}.v-application--is-ltr .ms-xl-n9{margin-left:-36px!important}.v-application--is-rtl .ms-xl-n9{margin-right:-36px!important}.v-application--is-ltr .ms-xl-n10{margin-left:-40px!important}.v-application--is-rtl .ms-xl-n10{margin-right:-40px!important}.v-application--is-ltr .ms-xl-n11{margin-left:-44px!important}.v-application--is-rtl .ms-xl-n11{margin-right:-44px!important}.v-application--is-ltr .ms-xl-n12{margin-left:-48px!important}.v-application--is-rtl .ms-xl-n12{margin-right:-48px!important}.v-application--is-ltr .ms-xl-n13{margin-left:-52px!important}.v-application--is-rtl .ms-xl-n13{margin-right:-52px!important}.v-application--is-ltr .ms-xl-n14{margin-left:-56px!important}.v-application--is-rtl .ms-xl-n14{margin-right:-56px!important}.v-application--is-ltr .ms-xl-n15{margin-left:-60px!important}.v-application--is-rtl .ms-xl-n15{margin-right:-60px!important}.v-application--is-ltr .ms-xl-n16{margin-left:-64px!important}.v-application--is-rtl .ms-xl-n16{margin-right:-64px!important}.v-application--is-ltr .me-xl-n1{margin-right:-4px!important}.v-application--is-rtl .me-xl-n1{margin-left:-4px!important}.v-application--is-ltr .me-xl-n2{margin-right:-8px!important}.v-application--is-rtl .me-xl-n2{margin-left:-8px!important}.v-application--is-ltr .me-xl-n3{margin-right:-12px!important}.v-application--is-rtl .me-xl-n3{margin-left:-12px!important}.v-application--is-ltr .me-xl-n4{margin-right:-16px!important}.v-application--is-rtl .me-xl-n4{margin-left:-16px!important}.v-application--is-ltr .me-xl-n5{margin-right:-20px!important}.v-application--is-rtl .me-xl-n5{margin-left:-20px!important}.v-application--is-ltr .me-xl-n6{margin-right:-24px!important}.v-application--is-rtl .me-xl-n6{margin-left:-24px!important}.v-application--is-ltr .me-xl-n7{margin-right:-28px!important}.v-application--is-rtl .me-xl-n7{margin-left:-28px!important}.v-application--is-ltr .me-xl-n8{margin-right:-32px!important}.v-application--is-rtl .me-xl-n8{margin-left:-32px!important}.v-application--is-ltr .me-xl-n9{margin-right:-36px!important}.v-application--is-rtl .me-xl-n9{margin-left:-36px!important}.v-application--is-ltr .me-xl-n10{margin-right:-40px!important}.v-application--is-rtl .me-xl-n10{margin-left:-40px!important}.v-application--is-ltr .me-xl-n11{margin-right:-44px!important}.v-application--is-rtl .me-xl-n11{margin-left:-44px!important}.v-application--is-ltr .me-xl-n12{margin-right:-48px!important}.v-application--is-rtl .me-xl-n12{margin-left:-48px!important}.v-application--is-ltr .me-xl-n13{margin-right:-52px!important}.v-application--is-rtl .me-xl-n13{margin-left:-52px!important}.v-application--is-ltr .me-xl-n14{margin-right:-56px!important}.v-application--is-rtl .me-xl-n14{margin-left:-56px!important}.v-application--is-ltr .me-xl-n15{margin-right:-60px!important}.v-application--is-rtl .me-xl-n15{margin-left:-60px!important}.v-application--is-ltr .me-xl-n16{margin-right:-64px!important}.v-application--is-rtl .me-xl-n16{margin-left:-64px!important}.v-application .pa-xl-0{padding:0!important}.v-application .pa-xl-1{padding:4px!important}.v-application .pa-xl-2{padding:8px!important}.v-application .pa-xl-3{padding:12px!important}.v-application .pa-xl-4{padding:16px!important}.v-application .pa-xl-5{padding:20px!important}.v-application .pa-xl-6{padding:24px!important}.v-application .pa-xl-7{padding:28px!important}.v-application .pa-xl-8{padding:32px!important}.v-application .pa-xl-9{padding:36px!important}.v-application .pa-xl-10{padding:40px!important}.v-application .pa-xl-11{padding:44px!important}.v-application .pa-xl-12{padding:48px!important}.v-application .pa-xl-13{padding:52px!important}.v-application .pa-xl-14{padding:56px!important}.v-application .pa-xl-15{padding:60px!important}.v-application .pa-xl-16{padding:64px!important}.v-application .px-xl-0{padding-right:0!important;padding-left:0!important}.v-application .px-xl-1{padding-right:4px!important;padding-left:4px!important}.v-application .px-xl-2{padding-right:8px!important;padding-left:8px!important}.v-application .px-xl-3{padding-right:12px!important;padding-left:12px!important}.v-application .px-xl-4{padding-right:16px!important;padding-left:16px!important}.v-application .px-xl-5{padding-right:20px!important;padding-left:20px!important}.v-application .px-xl-6{padding-right:24px!important;padding-left:24px!important}.v-application .px-xl-7{padding-right:28px!important;padding-left:28px!important}.v-application .px-xl-8{padding-right:32px!important;padding-left:32px!important}.v-application .px-xl-9{padding-right:36px!important;padding-left:36px!important}.v-application .px-xl-10{padding-right:40px!important;padding-left:40px!important}.v-application .px-xl-11{padding-right:44px!important;padding-left:44px!important}.v-application .px-xl-12{padding-right:48px!important;padding-left:48px!important}.v-application .px-xl-13{padding-right:52px!important;padding-left:52px!important}.v-application .px-xl-14{padding-right:56px!important;padding-left:56px!important}.v-application .px-xl-15{padding-right:60px!important;padding-left:60px!important}.v-application .px-xl-16{padding-right:64px!important;padding-left:64px!important}.v-application .py-xl-0{padding-top:0!important;padding-bottom:0!important}.v-application .py-xl-1{padding-top:4px!important;padding-bottom:4px!important}.v-application .py-xl-2{padding-top:8px!important;padding-bottom:8px!important}.v-application .py-xl-3{padding-top:12px!important;padding-bottom:12px!important}.v-application .py-xl-4{padding-top:16px!important;padding-bottom:16px!important}.v-application .py-xl-5{padding-top:20px!important;padding-bottom:20px!important}.v-application .py-xl-6{padding-top:24px!important;padding-bottom:24px!important}.v-application .py-xl-7{padding-top:28px!important;padding-bottom:28px!important}.v-application .py-xl-8{padding-top:32px!important;padding-bottom:32px!important}.v-application .py-xl-9{padding-top:36px!important;padding-bottom:36px!important}.v-application .py-xl-10{padding-top:40px!important;padding-bottom:40px!important}.v-application .py-xl-11{padding-top:44px!important;padding-bottom:44px!important}.v-application .py-xl-12{padding-top:48px!important;padding-bottom:48px!important}.v-application .py-xl-13{padding-top:52px!important;padding-bottom:52px!important}.v-application .py-xl-14{padding-top:56px!important;padding-bottom:56px!important}.v-application .py-xl-15{padding-top:60px!important;padding-bottom:60px!important}.v-application .py-xl-16{padding-top:64px!important;padding-bottom:64px!important}.v-application .pt-xl-0{padding-top:0!important}.v-application .pt-xl-1{padding-top:4px!important}.v-application .pt-xl-2{padding-top:8px!important}.v-application .pt-xl-3{padding-top:12px!important}.v-application .pt-xl-4{padding-top:16px!important}.v-application .pt-xl-5{padding-top:20px!important}.v-application .pt-xl-6{padding-top:24px!important}.v-application .pt-xl-7{padding-top:28px!important}.v-application .pt-xl-8{padding-top:32px!important}.v-application .pt-xl-9{padding-top:36px!important}.v-application .pt-xl-10{padding-top:40px!important}.v-application .pt-xl-11{padding-top:44px!important}.v-application .pt-xl-12{padding-top:48px!important}.v-application .pt-xl-13{padding-top:52px!important}.v-application .pt-xl-14{padding-top:56px!important}.v-application .pt-xl-15{padding-top:60px!important}.v-application .pt-xl-16{padding-top:64px!important}.v-application .pr-xl-0{padding-right:0!important}.v-application .pr-xl-1{padding-right:4px!important}.v-application .pr-xl-2{padding-right:8px!important}.v-application .pr-xl-3{padding-right:12px!important}.v-application .pr-xl-4{padding-right:16px!important}.v-application .pr-xl-5{padding-right:20px!important}.v-application .pr-xl-6{padding-right:24px!important}.v-application .pr-xl-7{padding-right:28px!important}.v-application .pr-xl-8{padding-right:32px!important}.v-application .pr-xl-9{padding-right:36px!important}.v-application .pr-xl-10{padding-right:40px!important}.v-application .pr-xl-11{padding-right:44px!important}.v-application .pr-xl-12{padding-right:48px!important}.v-application .pr-xl-13{padding-right:52px!important}.v-application .pr-xl-14{padding-right:56px!important}.v-application .pr-xl-15{padding-right:60px!important}.v-application .pr-xl-16{padding-right:64px!important}.v-application .pb-xl-0{padding-bottom:0!important}.v-application .pb-xl-1{padding-bottom:4px!important}.v-application .pb-xl-2{padding-bottom:8px!important}.v-application .pb-xl-3{padding-bottom:12px!important}.v-application .pb-xl-4{padding-bottom:16px!important}.v-application .pb-xl-5{padding-bottom:20px!important}.v-application .pb-xl-6{padding-bottom:24px!important}.v-application .pb-xl-7{padding-bottom:28px!important}.v-application .pb-xl-8{padding-bottom:32px!important}.v-application .pb-xl-9{padding-bottom:36px!important}.v-application .pb-xl-10{padding-bottom:40px!important}.v-application .pb-xl-11{padding-bottom:44px!important}.v-application .pb-xl-12{padding-bottom:48px!important}.v-application .pb-xl-13{padding-bottom:52px!important}.v-application .pb-xl-14{padding-bottom:56px!important}.v-application .pb-xl-15{padding-bottom:60px!important}.v-application .pb-xl-16{padding-bottom:64px!important}.v-application .pl-xl-0{padding-left:0!important}.v-application .pl-xl-1{padding-left:4px!important}.v-application .pl-xl-2{padding-left:8px!important}.v-application .pl-xl-3{padding-left:12px!important}.v-application .pl-xl-4{padding-left:16px!important}.v-application .pl-xl-5{padding-left:20px!important}.v-application .pl-xl-6{padding-left:24px!important}.v-application .pl-xl-7{padding-left:28px!important}.v-application .pl-xl-8{padding-left:32px!important}.v-application .pl-xl-9{padding-left:36px!important}.v-application .pl-xl-10{padding-left:40px!important}.v-application .pl-xl-11{padding-left:44px!important}.v-application .pl-xl-12{padding-left:48px!important}.v-application .pl-xl-13{padding-left:52px!important}.v-application .pl-xl-14{padding-left:56px!important}.v-application .pl-xl-15{padding-left:60px!important}.v-application .pl-xl-16{padding-left:64px!important}.v-application--is-ltr .ps-xl-0{padding-left:0!important}.v-application--is-rtl .ps-xl-0{padding-right:0!important}.v-application--is-ltr .ps-xl-1{padding-left:4px!important}.v-application--is-rtl .ps-xl-1{padding-right:4px!important}.v-application--is-ltr .ps-xl-2{padding-left:8px!important}.v-application--is-rtl .ps-xl-2{padding-right:8px!important}.v-application--is-ltr .ps-xl-3{padding-left:12px!important}.v-application--is-rtl .ps-xl-3{padding-right:12px!important}.v-application--is-ltr .ps-xl-4{padding-left:16px!important}.v-application--is-rtl .ps-xl-4{padding-right:16px!important}.v-application--is-ltr .ps-xl-5{padding-left:20px!important}.v-application--is-rtl .ps-xl-5{padding-right:20px!important}.v-application--is-ltr .ps-xl-6{padding-left:24px!important}.v-application--is-rtl .ps-xl-6{padding-right:24px!important}.v-application--is-ltr .ps-xl-7{padding-left:28px!important}.v-application--is-rtl .ps-xl-7{padding-right:28px!important}.v-application--is-ltr .ps-xl-8{padding-left:32px!important}.v-application--is-rtl .ps-xl-8{padding-right:32px!important}.v-application--is-ltr .ps-xl-9{padding-left:36px!important}.v-application--is-rtl .ps-xl-9{padding-right:36px!important}.v-application--is-ltr .ps-xl-10{padding-left:40px!important}.v-application--is-rtl .ps-xl-10{padding-right:40px!important}.v-application--is-ltr .ps-xl-11{padding-left:44px!important}.v-application--is-rtl .ps-xl-11{padding-right:44px!important}.v-application--is-ltr .ps-xl-12{padding-left:48px!important}.v-application--is-rtl .ps-xl-12{padding-right:48px!important}.v-application--is-ltr .ps-xl-13{padding-left:52px!important}.v-application--is-rtl .ps-xl-13{padding-right:52px!important}.v-application--is-ltr .ps-xl-14{padding-left:56px!important}.v-application--is-rtl .ps-xl-14{padding-right:56px!important}.v-application--is-ltr .ps-xl-15{padding-left:60px!important}.v-application--is-rtl .ps-xl-15{padding-right:60px!important}.v-application--is-ltr .ps-xl-16{padding-left:64px!important}.v-application--is-rtl .ps-xl-16{padding-right:64px!important}.v-application--is-ltr .pe-xl-0{padding-right:0!important}.v-application--is-rtl .pe-xl-0{padding-left:0!important}.v-application--is-ltr .pe-xl-1{padding-right:4px!important}.v-application--is-rtl .pe-xl-1{padding-left:4px!important}.v-application--is-ltr .pe-xl-2{padding-right:8px!important}.v-application--is-rtl .pe-xl-2{padding-left:8px!important}.v-application--is-ltr .pe-xl-3{padding-right:12px!important}.v-application--is-rtl .pe-xl-3{padding-left:12px!important}.v-application--is-ltr .pe-xl-4{padding-right:16px!important}.v-application--is-rtl .pe-xl-4{padding-left:16px!important}.v-application--is-ltr .pe-xl-5{padding-right:20px!important}.v-application--is-rtl .pe-xl-5{padding-left:20px!important}.v-application--is-ltr .pe-xl-6{padding-right:24px!important}.v-application--is-rtl .pe-xl-6{padding-left:24px!important}.v-application--is-ltr .pe-xl-7{padding-right:28px!important}.v-application--is-rtl .pe-xl-7{padding-left:28px!important}.v-application--is-ltr .pe-xl-8{padding-right:32px!important}.v-application--is-rtl .pe-xl-8{padding-left:32px!important}.v-application--is-ltr .pe-xl-9{padding-right:36px!important}.v-application--is-rtl .pe-xl-9{padding-left:36px!important}.v-application--is-ltr .pe-xl-10{padding-right:40px!important}.v-application--is-rtl .pe-xl-10{padding-left:40px!important}.v-application--is-ltr .pe-xl-11{padding-right:44px!important}.v-application--is-rtl .pe-xl-11{padding-left:44px!important}.v-application--is-ltr .pe-xl-12{padding-right:48px!important}.v-application--is-rtl .pe-xl-12{padding-left:48px!important}.v-application--is-ltr .pe-xl-13{padding-right:52px!important}.v-application--is-rtl .pe-xl-13{padding-left:52px!important}.v-application--is-ltr .pe-xl-14{padding-right:56px!important}.v-application--is-rtl .pe-xl-14{padding-left:56px!important}.v-application--is-ltr .pe-xl-15{padding-right:60px!important}.v-application--is-rtl .pe-xl-15{padding-left:60px!important}.v-application--is-ltr .pe-xl-16{padding-right:64px!important}.v-application--is-rtl .pe-xl-16{padding-left:64px!important}.v-application .text-xl-left{text-align:left!important}.v-application .text-xl-right{text-align:right!important}.v-application .text-xl-center{text-align:center!important}.v-application .text-xl-justify{text-align:justify!important}.v-application .text-xl-start{text-align:start!important}.v-application .text-xl-end{text-align:end!important}.v-application .text-xl-h1{font-size:6rem!important;line-height:6rem;letter-spacing:-.015625em!important}.v-application .text-xl-h1,.v-application .text-xl-h2{font-weight:300;font-family:Roboto,sans-serif!important}.v-application .text-xl-h2{font-size:3.75rem!important;line-height:3.75rem;letter-spacing:-.0083333333em!important}.v-application .text-xl-h3{font-size:3rem!important;line-height:3.125rem;letter-spacing:normal!important}.v-application .text-xl-h3,.v-application .text-xl-h4{font-weight:400;font-family:Roboto,sans-serif!important}.v-application .text-xl-h4{font-size:2.125rem!important;line-height:2.5rem;letter-spacing:.0073529412em!important}.v-application .text-xl-h5{font-size:1.5rem!important;font-weight:400;letter-spacing:normal!important}.v-application .text-xl-h5,.v-application .text-xl-h6{line-height:2rem;font-family:Roboto,sans-serif!important}.v-application .text-xl-h6{font-size:1.25rem!important;font-weight:500;letter-spacing:.0125em!important}.v-application .text-xl-subtitle-1{font-size:1rem!important;font-weight:400;line-height:1.75rem;letter-spacing:.009375em!important;font-family:Roboto,sans-serif!important}.v-application .text-xl-subtitle-2{font-size:.875rem!important;font-weight:500;line-height:1.375rem;letter-spacing:.0071428571em!important;font-family:Roboto,sans-serif!important}.v-application .text-xl-body-1{font-size:1rem!important;font-weight:400;line-height:1.5rem;letter-spacing:.03125em!important;font-family:Roboto,sans-serif!important}.v-application .text-xl-body-2{font-weight:400;line-height:1.25rem;letter-spacing:.0178571429em!important}.v-application .text-xl-body-2,.v-application .text-xl-button{font-size:.875rem!important;font-family:Roboto,sans-serif!important}.v-application .text-xl-button{font-weight:500;line-height:2.25rem;letter-spacing:.0892857143em!important;text-transform:uppercase!important}.v-application .text-xl-caption{font-weight:400;line-height:1.25rem;letter-spacing:.0333333333em!important}.v-application .text-xl-caption,.v-application .text-xl-overline{font-size:.75rem!important;font-family:Roboto,sans-serif!important}.v-application .text-xl-overline{font-weight:500;line-height:2rem;letter-spacing:.1666666667em!important;text-transform:uppercase!important}}@media print{.v-application .d-print-none{display:none!important}.v-application .d-print-inline{display:inline!important}.v-application .d-print-inline-block{display:inline-block!important}.v-application .d-print-block{display:block!important}.v-application .d-print-table{display:table!important}.v-application .d-print-table-row{display:table-row!important}.v-application .d-print-table-cell{display:table-cell!important}.v-application .d-print-flex{display:flex!important}.v-application .d-print-inline-flex{display:inline-flex!important}.v-application .float-print-none{float:none!important}.v-application .float-print-left{float:left!important}.v-application .float-print-right{float:right!important}.v-application--is-rtl .float-print-end{float:left!important}.v-application--is-ltr .float-print-end,.v-application--is-rtl .float-print-start{float:right!important}.v-application--is-ltr .float-print-start{float:left!important}}.theme--light.v-application{background:#fff;color:rgba(0,0,0,.87)}.theme--light.v-application .text--primary{color:rgba(0,0,0,.87)!important}.theme--light.v-application .text--secondary{color:rgba(0,0,0,.6)!important}.theme--light.v-application .text--disabled{color:rgba(0,0,0,.38)!important}.theme--dark.v-application{background:#121212;color:#fff}.theme--dark.v-application .text--primary{color:#fff!important}.theme--dark.v-application .text--secondary{color:hsla(0,0%,100%,.7)!important}.theme--dark.v-application .text--disabled{color:hsla(0,0%,100%,.5)!important}.v-application{display:flex}.v-application a{cursor:pointer}.v-application--is-rtl{direction:rtl}.v-application--wrap{flex:1 1 auto;backface-visibility:hidden;display:flex;flex-direction:column;min-height:100vh;max-width:100%;position:relative}@-moz-document url-prefix(){@media print{.v-application,.v-application--wrap{display:block}}}.theme--light.v-app-bar.v-toolbar.v-sheet{background-color:#f5f5f5}.theme--dark.v-app-bar.v-toolbar.v-sheet{background-color:#272727}.v-sheet.v-app-bar.v-toolbar{border-radius:0}.v-sheet.v-app-bar.v-toolbar:not(.v-sheet--outlined){box-shadow:0 2px 4px -1px rgba(0,0,0,.2),0 4px 5px 0 rgba(0,0,0,.14),0 1px 10px 0 rgba(0,0,0,.12)}.v-sheet.v-app-bar.v-toolbar.v-sheet--shaped{border-radius:24px 0}.v-app-bar:not([data-booted=true]){transition:none!important}.v-app-bar.v-app-bar--fixed{position:fixed;top:0;z-index:5}.v-app-bar.v-app-bar--hide-shadow{box-shadow:0 0 0 0 rgba(0,0,0,.2),0 0 0 0 rgba(0,0,0,.14),0 0 0 0 rgba(0,0,0,.12)!important}.v-app-bar--fade-img-on-scroll .v-toolbar__image .v-image__image{transition:opacity .4s cubic-bezier(.4,0,.2,1)}.v-app-bar.v-toolbar--prominent.v-app-bar--shrink-on-scroll .v-toolbar__content{will-change:height}.v-app-bar.v-toolbar--prominent.v-app-bar--shrink-on-scroll .v-toolbar__image{will-change:opacity}.v-app-bar.v-toolbar--prominent.v-app-bar--shrink-on-scroll.v-app-bar--collapse-on-scroll .v-toolbar__extension{display:none}.v-app-bar.v-toolbar--prominent.v-app-bar--shrink-on-scroll.v-app-bar--is-scrolled .v-toolbar__title{padding-top:9px}.v-app-bar.v-toolbar--prominent.v-app-bar--shrink-on-scroll.v-app-bar--is-scrolled:not(.v-app-bar--bottom) .v-toolbar__title{padding-bottom:9px}.v-app-bar.v-app-bar--shrink-on-scroll .v-toolbar__title{font-size:inherit}.v-app-bar-title__content,.v-app-bar-title__placeholder{overflow:hidden;text-overflow:ellipsis;white-space:nowrap}.v-app-bar-title__content{position:absolute}.theme--light.v-toolbar.v-sheet{background-color:#fff}.theme--dark.v-toolbar.v-sheet{background-color:#272727}.v-sheet.v-toolbar{border-radius:0}.v-sheet.v-toolbar:not(.v-sheet--outlined){box-shadow:0 2px 4px -1px rgba(0,0,0,.2),0 4px 5px 0 rgba(0,0,0,.14),0 1px 10px 0 rgba(0,0,0,.12)}.v-sheet.v-toolbar.v-sheet--shaped{border-radius:24px 0}.v-toolbar{contain:layout;display:block;flex:1 1 auto;max-width:100%;transition:transform .2s cubic-bezier(.4,0,.2,1),background-color .2s cubic-bezier(.4,0,.2,1),left .2s cubic-bezier(.4,0,.2,1),right .2s cubic-bezier(.4,0,.2,1),box-shadow .28s cubic-bezier(.4,0,.2,1),max-width .25s cubic-bezier(.4,0,.2,1),width .25s cubic-bezier(.4,0,.2,1);position:relative;box-shadow:0 2px 4px -1px rgba(0,0,0,.2),0 4px 5px 0 rgba(0,0,0,.14),0 1px 10px 0 rgba(0,0,0,.12)}.v-toolbar .v-input{padding-top:0;margin-top:0}.v-toolbar__content,.v-toolbar__extension{padding:4px 16px}.v-toolbar__content .v-btn.v-btn--icon.v-size--default,.v-toolbar__extension .v-btn.v-btn--icon.v-size--default{height:48px;width:48px}.v-application--is-ltr .v-toolbar__content>.v-btn.v-btn--icon:first-child,.v-application--is-ltr .v-toolbar__extension>.v-btn.v-btn--icon:first-child{margin-left:-12px}.v-application--is-rtl .v-toolbar__content>.v-btn.v-btn--icon:first-child,.v-application--is-rtl .v-toolbar__extension>.v-btn.v-btn--icon:first-child{margin-right:-12px}.v-application--is-ltr .v-toolbar__content>.v-btn.v-btn--icon:first-child+.v-toolbar__title,.v-application--is-ltr .v-toolbar__extension>.v-btn.v-btn--icon:first-child+.v-toolbar__title{padding-left:20px}.v-application--is-rtl .v-toolbar__content>.v-btn.v-btn--icon:first-child+.v-toolbar__title,.v-application--is-rtl .v-toolbar__extension>.v-btn.v-btn--icon:first-child+.v-toolbar__title{padding-right:20px}.v-application--is-ltr .v-toolbar__content>.v-btn.v-btn--icon:last-child,.v-application--is-ltr .v-toolbar__extension>.v-btn.v-btn--icon:last-child{margin-right:-12px}.v-application--is-rtl .v-toolbar__content>.v-btn.v-btn--icon:last-child,.v-application--is-rtl .v-toolbar__extension>.v-btn.v-btn--icon:last-child{margin-left:-12px}.v-toolbar__content>.v-tabs,.v-toolbar__extension>.v-tabs{height:inherit;margin-top:-4px;margin-bottom:-4px}.v-toolbar__content>.v-tabs>.v-slide-group.v-tabs-bar,.v-toolbar__extension>.v-tabs>.v-slide-group.v-tabs-bar{background-color:inherit;height:inherit}.v-toolbar__content>.v-tabs:first-child,.v-toolbar__extension>.v-tabs:first-child{margin-left:-16px}.v-toolbar__content>.v-tabs:last-child,.v-toolbar__extension>.v-tabs:last-child{margin-right:-16px}.v-toolbar__content,.v-toolbar__extension{align-items:center;display:flex;position:relative;z-index:0}.v-toolbar__image{position:absolute;top:0;bottom:0;width:100%;z-index:0;contain:strict}.v-toolbar__image,.v-toolbar__image .v-image{border-radius:inherit}.v-toolbar__items{display:flex;height:inherit}.v-toolbar__items>.v-btn{border-radius:0;height:100%!important;max-height:none}.v-toolbar__title{font-size:1.25rem;line-height:1.5;overflow:hidden;text-overflow:ellipsis;white-space:nowrap}.v-toolbar.v-toolbar--absolute{position:absolute;top:0;z-index:1}.v-toolbar.v-toolbar--bottom{top:auto;bottom:0}.v-toolbar.v-toolbar--collapse .v-toolbar__title{white-space:nowrap}.v-toolbar.v-toolbar--collapsed{max-width:112px;overflow:hidden}.v-application--is-ltr .v-toolbar.v-toolbar--collapsed{border-bottom-right-radius:24px}.v-application--is-rtl .v-toolbar.v-toolbar--collapsed{border-bottom-left-radius:24px}.v-toolbar.v-toolbar--collapsed .v-toolbar__extension,.v-toolbar.v-toolbar--collapsed .v-toolbar__title{display:none}.v-toolbar--dense .v-toolbar__content,.v-toolbar--dense .v-toolbar__extension{padding-top:0;padding-bottom:0}.v-toolbar--flat{box-shadow:0 0 0 0 rgba(0,0,0,.2),0 0 0 0 rgba(0,0,0,.14),0 0 0 0 rgba(0,0,0,.12)!important}.v-toolbar--floating{display:inline-flex}.v-toolbar--prominent .v-toolbar__content{align-items:flex-start}.v-toolbar--prominent .v-toolbar__title{font-size:1.5rem;padding-top:6px}.v-toolbar--prominent:not(.v-toolbar--bottom) .v-toolbar__title{align-self:flex-end;padding-bottom:6px;padding-top:0}.theme--light.v-sheet{background-color:#fff;border-color:#fff;color:rgba(0,0,0,.87)}.theme--light.v-sheet--outlined{border:thin solid rgba(0,0,0,.12)}.theme--dark.v-sheet{background-color:#1e1e1e;border-color:#1e1e1e;color:#fff}.theme--dark.v-sheet--outlined{border:thin solid hsla(0,0%,100%,.12)}.v-sheet{border-radius:0}.v-sheet:not(.v-sheet--outlined){box-shadow:0 0 0 0 rgba(0,0,0,.2),0 0 0 0 rgba(0,0,0,.14),0 0 0 0 rgba(0,0,0,.12)}.v-sheet.v-sheet--shaped{border-radius:24px 0}.v-btn:not(.v-btn--outlined).accent,.v-btn:not(.v-btn--outlined).error,.v-btn:not(.v-btn--outlined).info,.v-btn:not(.v-btn--outlined).primary,.v-btn:not(.v-btn--outlined).secondary,.v-btn:not(.v-btn--outlined).success,.v-btn:not(.v-btn--outlined).warning{color:#fff}.theme--light.v-btn{color:rgba(0,0,0,.87)}.theme--light.v-btn.v-btn--disabled,.theme--light.v-btn.v-btn--disabled .v-btn__loading,.theme--light.v-btn.v-btn--disabled .v-icon{color:rgba(0,0,0,.26)!important}.theme--light.v-btn.v-btn--disabled.v-btn--has-bg{background-color:rgba(0,0,0,.12)!important}.theme--light.v-btn.v-btn--has-bg{background-color:#f5f5f5}.theme--light.v-btn.v-btn--outlined.v-btn--text{border-color:rgba(0,0,0,.12)}.theme--light.v-btn.v-btn--icon{color:rgba(0,0,0,.54)}.theme--light.v-btn:hover:before{opacity:.08}.theme--light.v-btn:focus:before{opacity:.24}.theme--light.v-btn--active:before,.theme--light.v-btn--active:hover:before{opacity:.18}.theme--light.v-btn--active:focus:before{opacity:.16}.theme--dark.v-btn{color:#fff}.theme--dark.v-btn.v-btn--disabled,.theme--dark.v-btn.v-btn--disabled .v-btn__loading,.theme--dark.v-btn.v-btn--disabled .v-icon{color:hsla(0,0%,100%,.3)!important}.theme--dark.v-btn.v-btn--disabled.v-btn--has-bg{background-color:hsla(0,0%,100%,.12)!important}.theme--dark.v-btn.v-btn--has-bg{background-color:#272727}.theme--dark.v-btn.v-btn--outlined.v-btn--text{border-color:hsla(0,0%,100%,.12)}.theme--dark.v-btn.v-btn--icon{color:#fff}.theme--dark.v-btn:hover:before{opacity:.08}.theme--dark.v-btn:focus:before{opacity:.24}.theme--dark.v-btn--active:before,.theme--dark.v-btn--active:hover:before{opacity:.18}.theme--dark.v-btn--active:focus:before{opacity:.32}.v-btn{align-items:center;border-radius:4px;display:inline-flex;flex:0 0 auto;font-weight:500;letter-spacing:.0892857143em;justify-content:center;outline:0;position:relative;text-decoration:none;text-indent:.0892857143em;text-transform:uppercase;transition-duration:.28s;transition-property:box-shadow,transform,opacity;transition-timing-function:cubic-bezier(.4,0,.2,1);user-select:none;vertical-align:middle;white-space:nowrap}.v-btn.v-size--x-small{font-size:.625rem}.v-btn.v-size--small{font-size:.75rem}.v-btn.v-size--default,.v-btn.v-size--large{font-size:.875rem}.v-btn.v-size--x-large{font-size:1rem}.v-btn:before{background-color:currentColor;border-radius:inherit;bottom:0;color:inherit;content:"";left:0;opacity:0;pointer-events:none;position:absolute;right:0;top:0;transition:opacity .2s cubic-bezier(.4,0,.6,1)}.v-btn:not(.v-btn--disabled){will-change:box-shadow}.v-btn:not(.v-btn--round).v-size--x-small{height:20px;min-width:36px;padding:0 8.8888888889px}.v-btn:not(.v-btn--round).v-size--small{height:28px;min-width:50px;padding:0 12.4444444444px}.v-btn:not(.v-btn--round).v-size--default{height:36px;min-width:64px;padding:0 16px}.v-btn:not(.v-btn--round).v-size--large{height:44px;min-width:78px;padding:0 19.5555555556px}.v-btn:not(.v-btn--round).v-size--x-large{height:52px;min-width:92px;padding:0 23.1111111111px}.v-btn>.v-btn__content .v-icon{color:inherit}.v-btn__content{align-items:center;color:inherit;display:flex;flex:1 0 auto;justify-content:inherit;line-height:normal;position:relative;transition:inherit;transition-property:opacity}.v-btn__content .v-icon.v-icon--left,.v-btn__content .v-icon.v-icon--right{font-size:18px;height:18px;width:18px}.v-application--is-ltr .v-btn__content .v-icon--left{margin-left:-4px;margin-right:8px}.v-application--is-ltr .v-btn__content .v-icon--right,.v-application--is-rtl .v-btn__content .v-icon--left{margin-left:8px;margin-right:-4px}.v-application--is-rtl .v-btn__content .v-icon--right{margin-left:-4px;margin-right:8px}.v-btn__loader{align-items:center;display:flex;height:100%;justify-content:center;left:0;position:absolute;top:0;width:100%}.v-btn--absolute.v-btn--right,.v-btn--fixed.v-btn--right{right:16px}.v-btn--absolute.v-btn--left,.v-btn--fixed.v-btn--left{left:16px}.v-btn--absolute.v-btn--top,.v-btn--fixed.v-btn--top{top:16px}.v-btn--absolute.v-btn--bottom,.v-btn--fixed.v-btn--bottom{bottom:16px}.v-btn--absolute{position:absolute}.v-btn--fixed{position:fixed}.v-btn--block{display:flex;flex:1 0 auto;min-width:100%!important;max-width:auto}.v-btn--is-elevated{box-shadow:0 3px 1px -2px rgba(0,0,0,.2),0 2px 2px 0 rgba(0,0,0,.14),0 1px 5px 0 rgba(0,0,0,.12)}.v-btn--is-elevated:after{box-shadow:0 2px 4px -1px rgba(0,0,0,.2),0 4px 5px 0 rgba(0,0,0,.14),0 1px 10px 0 rgba(0,0,0,.12)}.v-btn--is-elevated:active{box-shadow:0 5px 5px -3px rgba(0,0,0,.2),0 8px 10px 1px rgba(0,0,0,.14),0 3px 14px 2px rgba(0,0,0,.12)}.v-btn--is-elevated.v-btn--fab{box-shadow:0 3px 5px -1px rgba(0,0,0,.2),0 6px 10px 0 rgba(0,0,0,.14),0 1px 18px 0 rgba(0,0,0,.12)}.v-btn--is-elevated.v-btn--fab:after{box-shadow:0 5px 5px -3px rgba(0,0,0,.2),0 8px 10px 1px rgba(0,0,0,.14),0 3px 14px 2px rgba(0,0,0,.12)}.v-btn--is-elevated.v-btn--fab:active{box-shadow:0 7px 8px -4px rgba(0,0,0,.2),0 12px 17px 2px rgba(0,0,0,.14),0 5px 22px 4px rgba(0,0,0,.12)}.v-btn--disabled{pointer-events:none}.v-btn--fab,.v-btn--icon{min-height:0;min-width:0;padding:0}.v-btn--fab.v-size--x-small .v-icon,.v-btn--icon.v-size--x-small .v-icon{height:18px;font-size:18px;width:18px}.v-btn--fab.v-size--default .v-icon,.v-btn--fab.v-size--small .v-icon,.v-btn--icon.v-size--default .v-icon,.v-btn--icon.v-size--small .v-icon{height:24px;font-size:24px;width:24px}.v-btn--fab.v-size--large .v-icon,.v-btn--icon.v-size--large .v-icon{height:28px;font-size:28px;width:28px}.v-btn--fab.v-size--x-large .v-icon,.v-btn--icon.v-size--x-large .v-icon{height:32px;font-size:32px;width:32px}.v-btn--icon.v-size--x-small{height:20px;width:20px}.v-btn--icon.v-size--small{height:28px;width:28px}.v-btn--icon.v-size--default{height:36px;width:36px}.v-btn--icon.v-size--large{height:44px;width:44px}.v-btn--icon.v-size--x-large{height:52px;width:52px}.v-btn--fab.v-btn--absolute,.v-btn--fab.v-btn--fixed{z-index:4}.v-btn--fab.v-size--x-small{height:32px;width:32px}.v-btn--fab.v-size--x-small.v-btn--absolute.v-btn--bottom{bottom:-16px}.v-btn--fab.v-size--x-small.v-btn--absolute.v-btn--top{top:-16px}.v-btn--fab.v-size--small{height:40px;width:40px}.v-btn--fab.v-size--small.v-btn--absolute.v-btn--bottom{bottom:-20px}.v-btn--fab.v-size--small.v-btn--absolute.v-btn--top{top:-20px}.v-btn--fab.v-size--default{height:56px;width:56px}.v-btn--fab.v-size--default.v-btn--absolute.v-btn--bottom{bottom:-28px}.v-btn--fab.v-size--default.v-btn--absolute.v-btn--top{top:-28px}.v-btn--fab.v-size--large{height:64px;width:64px}.v-btn--fab.v-size--large.v-btn--absolute.v-btn--bottom{bottom:-32px}.v-btn--fab.v-size--large.v-btn--absolute.v-btn--top{top:-32px}.v-btn--fab.v-size--x-large{height:72px;width:72px}.v-btn--fab.v-size--x-large.v-btn--absolute.v-btn--bottom{bottom:-36px}.v-btn--fab.v-size--x-large.v-btn--absolute.v-btn--top{top:-36px}.v-btn--loading{pointer-events:none;transition:none}.v-btn--loading .v-btn__content{opacity:0}.v-btn--outlined{border:thin solid currentColor}.v-btn--plain:before{display:none}.v-btn--plain:not(.v-btn--active):not(.v-btn--loading):not(:focus):not(:hover) .v-btn__content{opacity:.62}.v-btn--round{border-radius:50%}.v-btn--rounded{border-radius:28px}.v-btn--tile{border-radius:0}.v-ripple__container{border-radius:inherit;width:100%;height:100%;z-index:0;contain:strict}.v-ripple__animation,.v-ripple__container{color:inherit;position:absolute;left:0;top:0;overflow:hidden;pointer-events:none}.v-ripple__animation{border-radius:50%;background:currentColor;opacity:0;will-change:transform,opacity}.v-ripple__animation--enter{transition:none}.v-ripple__animation--in{transition:transform .25s cubic-bezier(.4,0,.2,1),opacity .1s cubic-bezier(.4,0,.2,1)}.v-ripple__animation--out{transition:opacity .3s cubic-bezier(.4,0,.2,1)}.v-progress-circular{position:relative;display:inline-flex;vertical-align:middle;justify-content:center;align-items:center}.v-progress-circular>svg{width:100%;height:100%;margin:auto;position:absolute;top:0;bottom:0;left:0;right:0;z-index:0}.v-progress-circular--indeterminate>svg{animation:progress-circular-rotate 1.4s linear infinite;transform-origin:center center;transition:all .2s ease-in-out}.v-progress-circular--indeterminate .v-progress-circular__overlay{animation:progress-circular-dash 1.4s ease-in-out infinite;stroke-linecap:round;stroke-dasharray:80,200;stroke-dashoffset:0px}.v-progress-circular--indeterminate:not(.v-progress-circular--visible) .v-progress-circular__overlay,.v-progress-circular--indeterminate:not(.v-progress-circular--visible)>svg{animation-play-state:paused!important}.v-progress-circular__info{align-items:center;display:flex;justify-content:center}.v-progress-circular__underlay{stroke:hsla(0,0%,62%,.4);z-index:1}.v-progress-circular__overlay{stroke:currentColor;z-index:2;transition:all .6s ease-in-out}@keyframes progress-circular-dash{0%{stroke-dasharray:1,200;stroke-dashoffset:0px}50%{stroke-dasharray:100,200;stroke-dashoffset:-15px}to{stroke-dasharray:100,200;stroke-dashoffset:-125px}}@keyframes progress-circular-rotate{to{transform:rotate(1turn)}}.theme--light.v-icon{color:rgba(0,0,0,.54)}.theme--light.v-icon:focus:after{opacity:.12}.theme--light.v-icon.v-icon.v-icon--disabled{color:rgba(0,0,0,.38)!important}.theme--dark.v-icon{color:#fff}.theme--dark.v-icon:focus:after{opacity:.24}.theme--dark.v-icon.v-icon.v-icon--disabled{color:hsla(0,0%,100%,.5)!important}.v-icon.v-icon{align-items:center;display:inline-flex;font-feature-settings:"liga";font-size:24px;justify-content:center;letter-spacing:normal;line-height:1;position:relative;text-indent:0;transition:.3s cubic-bezier(.25,.8,.5,1),visibility 0s;vertical-align:middle;user-select:none}.v-icon.v-icon:after{background-color:currentColor;border-radius:50%;content:"";display:inline-block;height:100%;left:0;opacity:0;pointer-events:none;position:absolute;top:0;transform:scale(1.3);width:100%;transition:opacity .2s cubic-bezier(.4,0,.6,1)}.v-icon.v-icon--dense{font-size:20px}.v-icon--right{margin-left:8px}.v-icon--left{margin-right:8px}.v-icon.v-icon.v-icon--link{cursor:pointer;outline:none}.v-icon--disabled{pointer-events:none}.v-icon--dense__component,.v-icon--dense__svg{height:20px}.v-icon__component,.v-icon__svg{height:24px;width:24px}.v-icon__svg{fill:currentColor}.v-main{display:flex;flex:1 0 auto;max-width:100%;transition:.2s cubic-bezier(.4,0,.2,1)}.v-main:not([data-booted=true]){transition:none!important}.v-main__wrap{flex:1 1 auto;max-width:100%;position:relative}@-moz-document url-prefix(){@media print{.v-main{display:block}}} \ No newline at end of file diff --git a/frontend/dist/static/img/logo.63a7d78d.svg b/frontend/dist/static/img/logo.63a7d78d.svg deleted file mode 100644 index 145b6d1..0000000 --- a/frontend/dist/static/img/logo.63a7d78d.svg +++ /dev/null @@ -1 +0,0 @@ -Artboard 46 diff --git a/frontend/dist/static/js/app.7b248217.js b/frontend/dist/static/js/app.7b248217.js deleted file mode 100644 index 30ebe6b..0000000 --- a/frontend/dist/static/js/app.7b248217.js +++ /dev/null @@ -1,2 +0,0 @@ -(function(t){function e(e){for(var r,o,i=e[0],u=e[1],c=e[2],f=0,p=[];f\n \n \n \n \n \n\n \n

\n Welcome to Vuetify\n

\n\n

\n For help and collaboration with other Vuetify developers,\n
please join our online\n Discord Community\n

\n
\n\n \n

\n What's next?\n

\n\n \n \n {{ next.text }}\n \n \n \n\n \n

\n Important Links\n

\n\n \n \n {{ link.text }}\n \n \n \n\n \n

\n Ecosystem\n

\n\n \n \n {{ eco.text }}\n \n \n \n
\n
\n\n\n\n","import mod from \"-!../../node_modules/cache-loader/dist/cjs.js??ref--12-0!../../node_modules/thread-loader/dist/cjs.js!../../node_modules/babel-loader/lib/index.js!../../node_modules/cache-loader/dist/cjs.js??ref--0-0!../../node_modules/vue-loader/lib/index.js??vue-loader-options!./HelloWorld.vue?vue&type=script&lang=js&\"; export default mod; export * from \"-!../../node_modules/cache-loader/dist/cjs.js??ref--12-0!../../node_modules/thread-loader/dist/cjs.js!../../node_modules/babel-loader/lib/index.js!../../node_modules/cache-loader/dist/cjs.js??ref--0-0!../../node_modules/vue-loader/lib/index.js??vue-loader-options!./HelloWorld.vue?vue&type=script&lang=js&\"","import { render, staticRenderFns } from \"./HelloWorld.vue?vue&type=template&id=023580a6&\"\nimport script from \"./HelloWorld.vue?vue&type=script&lang=js&\"\nexport * from \"./HelloWorld.vue?vue&type=script&lang=js&\"\n\n\n/* normalize component */\nimport normalizer from \"!../../node_modules/vue-loader/lib/runtime/componentNormalizer.js\"\nvar component = normalizer(\n script,\n render,\n staticRenderFns,\n false,\n null,\n null,\n null\n \n)\n\nexport default component.exports\n\n/* vuetify-loader */\nimport installComponents from \"!../../node_modules/vuetify-loader/lib/runtime/installComponents.js\"\nimport { VCol } from 'vuetify/lib/components/VGrid';\nimport { VContainer } from 'vuetify/lib/components/VGrid';\nimport { VImg } from 'vuetify/lib/components/VImg';\nimport { VRow } from 'vuetify/lib/components/VGrid';\ninstallComponents(component, {VCol,VContainer,VImg,VRow})\n","\n\n\n","import mod from \"-!../node_modules/cache-loader/dist/cjs.js??ref--12-0!../node_modules/thread-loader/dist/cjs.js!../node_modules/babel-loader/lib/index.js!../node_modules/cache-loader/dist/cjs.js??ref--0-0!../node_modules/vue-loader/lib/index.js??vue-loader-options!./App.vue?vue&type=script&lang=js&\"; export default mod; export * from \"-!../node_modules/cache-loader/dist/cjs.js??ref--12-0!../node_modules/thread-loader/dist/cjs.js!../node_modules/babel-loader/lib/index.js!../node_modules/cache-loader/dist/cjs.js??ref--0-0!../node_modules/vue-loader/lib/index.js??vue-loader-options!./App.vue?vue&type=script&lang=js&\"","import { render, staticRenderFns } from \"./App.vue?vue&type=template&id=3db22220&\"\nimport script from \"./App.vue?vue&type=script&lang=js&\"\nexport * from \"./App.vue?vue&type=script&lang=js&\"\n\n\n/* normalize component */\nimport normalizer from \"!../node_modules/vue-loader/lib/runtime/componentNormalizer.js\"\nvar component = normalizer(\n script,\n render,\n staticRenderFns,\n false,\n null,\n null,\n null\n \n)\n\nexport default component.exports\n\n/* vuetify-loader */\nimport installComponents from \"!../node_modules/vuetify-loader/lib/runtime/installComponents.js\"\nimport { VApp } from 'vuetify/lib/components/VApp';\nimport { VAppBar } from 'vuetify/lib/components/VAppBar';\nimport { VBtn } from 'vuetify/lib/components/VBtn';\nimport { VIcon } from 'vuetify/lib/components/VIcon';\nimport { VImg } from 'vuetify/lib/components/VImg';\nimport { VMain } from 'vuetify/lib/components/VMain';\nimport { VSpacer } from 'vuetify/lib/components/VGrid';\ninstallComponents(component, {VApp,VAppBar,VBtn,VIcon,VImg,VMain,VSpacer})\n","import Vue from 'vue';\nimport Vuetify from 'vuetify/lib/framework';\n\nVue.use(Vuetify);\n\nexport default new Vuetify({\n});\n","import Vue from 'vue'\nimport './plugins/axios'\nimport App from './App.vue'\nimport vuetify from './plugins/vuetify'\n\nVue.config.productionTip = false\n\nnew Vue({\n vuetify,\n render: h => h(App)\n}).$mount('#app')\n","module.exports = __webpack_public_path__ + \"static/img/logo.63a7d78d.svg\";"],"sourceRoot":""} \ No newline at end of file diff --git a/frontend/dist/static/js/chunk-vendors.84a48fc6.js b/frontend/dist/static/js/chunk-vendors.84a48fc6.js deleted file mode 100644 index def008e..0000000 --- a/frontend/dist/static/js/chunk-vendors.84a48fc6.js +++ /dev/null @@ -1,15 +0,0 @@ -(window["webpackJsonp"]=window["webpackJsonp"]||[]).push([["chunk-vendors"],{"00ee":function(t,e,n){var r=n("b622"),i=r("toStringTag"),o={};o[i]="z",t.exports="[object z]"===String(o)},"0366":function(t,e,n){var r=n("1c0b");t.exports=function(t,e,n){if(r(t),void 0===e)return t;switch(n){case 0:return function(){return t.call(e)};case 1:return function(n){return t.call(e,n)};case 2:return function(n,r){return t.call(e,n,r)};case 3:return function(n,r,i){return t.call(e,n,r,i)}}return function(){return t.apply(e,arguments)}}},"0481":function(t,e,n){"use strict";var r=n("23e7"),i=n("a2bf"),o=n("7b0b"),a=n("50c4"),s=n("a691"),c=n("65f0");r({target:"Array",proto:!0},{flat:function(){var t=arguments.length?arguments[0]:void 0,e=o(this),n=a(e.length),r=c(e,0);return r.length=i(r,e,e,n,0,void 0===t?1:s(t)),r}})},"0538":function(t,e,n){"use strict";var r=n("1c0b"),i=n("861d"),o=[].slice,a={},s=function(t,e,n){if(!(e in a)){for(var r=[],i=0;it.length)&&(e=t.length);for(var n=0,r=new Array(e);n]*>)/g,s=/\$([$&'`]|\d{1,2})/g;t.exports=function(t,e,n,c,u,l){var f=n+t.length,d=c.length,p=s;return void 0!==u&&(u=r(u),p=a),o.call(l,p,(function(r,o){var a;switch(o.charAt(0)){case"$":return"$";case"&":return t;case"`":return e.slice(0,n);case"'":return e.slice(f);case"<":a=u[o.slice(1,-1)];break;default:var s=+o;if(0===s)return r;if(s>d){var l=i(s/10);return 0===l?r:l<=d?void 0===c[l-1]?o.charAt(1):c[l-1]+o.charAt(1):r}a=c[s-1]}return void 0===a?"":a}))}},"0cfb":function(t,e,n){var r=n("83ab"),i=n("d039"),o=n("cc12");t.exports=!r&&!i((function(){return 7!=Object.defineProperty(o("div"),"a",{get:function(){return 7}}).a}))},"0df6":function(t,e,n){"use strict";t.exports=function(t){return function(e){return t.apply(null,e)}}},"0fd9":function(t,e,n){"use strict";var r=n("ade3"),i=n("5530"),o=(n("caad"),n("2532"),n("99af"),n("b64b"),n("ac1f"),n("5319"),n("4ec9"),n("d3b7"),n("3ca3"),n("ddb0"),n("159b"),n("4b85"),n("2b0e")),a=n("d9f7"),s=n("80d2"),c=["sm","md","lg","xl"],u=["start","end","center"];function l(t,e){return c.reduce((function(n,r){return n[t+Object(s["o"])(r)]=e(),n}),{})}var f=function(t){return[].concat(u,["baseline","stretch"]).includes(t)},d=l("align",(function(){return{type:String,default:null,validator:f}})),p=function(t){return[].concat(u,["space-between","space-around"]).includes(t)},h=l("justify",(function(){return{type:String,default:null,validator:p}})),v=function(t){return[].concat(u,["space-between","space-around","stretch"]).includes(t)},m=l("alignContent",(function(){return{type:String,default:null,validator:v}})),g={align:Object.keys(d),justify:Object.keys(h),alignContent:Object.keys(m)},b={align:"align",justify:"justify",alignContent:"align-content"};function y(t,e,n){var r=b[t];if(null!=n){if(e){var i=e.replace(t,"");r+="-".concat(i)}return r+="-".concat(n),r.toLowerCase()}}var x=new Map;e["a"]=o["a"].extend({name:"v-row",functional:!0,props:Object(i["a"])(Object(i["a"])(Object(i["a"])({tag:{type:String,default:"div"},dense:Boolean,noGutters:Boolean,align:{type:String,default:null,validator:f}},d),{},{justify:{type:String,default:null,validator:p}},h),{},{alignContent:{type:String,default:null,validator:v}},m),render:function(t,e){var n=e.props,i=e.data,o=e.children,s="";for(var c in n)s+=String(n[c]);var u=x.get(s);return u||function(){var t,e;for(e in u=[],g)g[e].forEach((function(t){var r=n[t],i=y(e,t,r);i&&u.push(i)}));u.push((t={"no-gutters":n.noGutters,"row--dense":n.dense},Object(r["a"])(t,"align-".concat(n.align),n.align),Object(r["a"])(t,"justify-".concat(n.justify),n.justify),Object(r["a"])(t,"align-content-".concat(n.alignContent),n.alignContent),t)),x.set(s,u)}(),t(n.tag,Object(a["a"])(i,{staticClass:"row",class:u}),o)}})},1148:function(t,e,n){"use strict";var r=n("a691"),i=n("1d80");t.exports=function(t){var e=String(i(this)),n="",o=r(t);if(o<0||o==1/0)throw RangeError("Wrong number of repetitions");for(;o>0;(o>>>=1)&&(e+=e))1&o&&(n+=e);return n}},1276:function(t,e,n){"use strict";var r=n("d784"),i=n("44e7"),o=n("825a"),a=n("1d80"),s=n("4840"),c=n("8aa5"),u=n("50c4"),l=n("14c3"),f=n("9263"),d=n("9f7f"),p=d.UNSUPPORTED_Y,h=[].push,v=Math.min,m=4294967295;r("split",2,(function(t,e,n){var r;return r="c"=="abbc".split(/(b)*/)[1]||4!="test".split(/(?:)/,-1).length||2!="ab".split(/(?:ab)*/).length||4!=".".split(/(.?)(.?)/).length||".".split(/()()/).length>1||"".split(/.?/).length?function(t,n){var r=String(a(this)),o=void 0===n?m:n>>>0;if(0===o)return[];if(void 0===t)return[r];if(!i(t))return e.call(r,t,o);var s,c,u,l=[],d=(t.ignoreCase?"i":"")+(t.multiline?"m":"")+(t.unicode?"u":"")+(t.sticky?"y":""),p=0,v=new RegExp(t.source,d+"g");while(s=f.call(v,r)){if(c=v.lastIndex,c>p&&(l.push(r.slice(p,s.index)),s.length>1&&s.index=o))break;v.lastIndex===s.index&&v.lastIndex++}return p===r.length?!u&&v.test("")||l.push(""):l.push(r.slice(p)),l.length>o?l.slice(0,o):l}:"0".split(void 0,0).length?function(t,n){return void 0===t&&0===n?[]:e.call(this,t,n)}:e,[function(e,n){var i=a(this),o=void 0==e?void 0:e[t];return void 0!==o?o.call(e,i,n):r.call(String(i),e,n)},function(t,i){var a=n(r,t,this,i,r!==e);if(a.done)return a.value;var f=o(t),d=String(this),h=s(f,RegExp),g=f.unicode,b=(f.ignoreCase?"i":"")+(f.multiline?"m":"")+(f.unicode?"u":"")+(p?"g":"y"),y=new h(p?"^(?:"+f.source+")":f,b),x=void 0===i?m:i>>>0;if(0===x)return[];if(0===d.length)return null===l(y,d)?[d]:[];var w=0,_=0,S=[];while(_4}(function(t){t["xSmall"]="12px",t["small"]="16px",t["default"]="24px",t["medium"]="28px",t["large"]="36px",t["xLarge"]="40px"})(r||(r={}));var h=Object(f["a"])(o["a"],a["a"],s["a"],c["a"]).extend({name:"v-icon",props:{dense:Boolean,disabled:Boolean,left:Boolean,right:Boolean,size:[Number,String],tag:{type:String,required:!1,default:"i"}},computed:{medium:function(){return!1},hasClickListener:function(){return Boolean(this.listeners$.click||this.listeners$["!click"])}},methods:{getIcon:function(){var t="";return this.$slots.default&&(t=this.$slots.default[0].text.trim()),Object(u["n"])(this,t)},getSize:function(){var t={xSmall:this.xSmall,small:this.small,medium:this.medium,large:this.large,xLarge:this.xLarge},e=Object(u["k"])(t).find((function(e){return t[e]}));return e&&r[e]||Object(u["d"])(this.size)},getDefaultData:function(){return{staticClass:"v-icon notranslate",class:{"v-icon--disabled":this.disabled,"v-icon--left":this.left,"v-icon--link":this.hasClickListener,"v-icon--right":this.right,"v-icon--dense":this.dense},attrs:Object(i["a"])({"aria-hidden":!this.hasClickListener,disabled:this.hasClickListener&&this.disabled,type:this.hasClickListener?"button":void 0},this.attrs$),on:this.listeners$}},getSvgWrapperData:function(){var t=this.getSize(),e=Object(i["a"])(Object(i["a"])({},this.getDefaultData()),{},{style:t?{fontSize:t,height:t,width:t}:void 0});return this.applyColors(e),e},applyColors:function(t){t.class=Object(i["a"])(Object(i["a"])({},t.class),this.themeClasses),this.setTextColor(this.color,t)},renderFontIcon:function(t,e){var n=[],r=this.getDefaultData(),i="material-icons",o=t.indexOf("-"),a=o<=-1;a?n.push(t):(i=t.slice(0,o),d(i)&&(i="")),r.class[i]=!0,r.class[t]=!a;var s=this.getSize();return s&&(r.style={fontSize:s}),this.applyColors(r),e(this.hasClickListener?"button":this.tag,r,n)},renderSvgIcon:function(t,e){var n={class:"v-icon__svg",attrs:{xmlns:"http://www.w3.org/2000/svg",viewBox:"0 0 24 24",role:"img","aria-hidden":!0}},r=this.getSize();return r&&(n.style={fontSize:r,height:r,width:r}),e(this.hasClickListener?"button":"span",this.getSvgWrapperData(),[e("svg",n,[e("path",{attrs:{d:t}})])])},renderSvgIconComponent:function(t,e){var n={class:{"v-icon__component":!0}},r=this.getSize();r&&(n.style={fontSize:r,height:r,width:r}),this.applyColors(n);var i=t.component;return n.props=t.props,n.nativeOn=n.on,e(this.hasClickListener?"button":"span",this.getSvgWrapperData(),[e(i,n)])}},render:function(t){var e=this.getIcon();return"string"===typeof e?p(e)?this.renderSvgIcon(e,t):this.renderFontIcon(e,t):this.renderSvgIconComponent(e,t)}});e["a"]=l["a"].extend({name:"v-icon",$_wrapperFor:h,functional:!0,render:function(t,e){var n=e.data,r=e.children,i="";return n.domProps&&(i=n.domProps.textContent||n.domProps.innerHTML||i,delete n.domProps.textContent,delete n.domProps.innerHTML),t(h,n,i?[i]:r)}})},"14c3":function(t,e,n){var r=n("c6b6"),i=n("9263");t.exports=function(t,e){var n=t.exec;if("function"===typeof n){var o=n.call(t,e);if("object"!==typeof o)throw TypeError("RegExp exec method returned something other than an Object or null");return o}if("RegExp"!==r(t))throw TypeError("RegExp#exec called on incompatible receiver");return i.call(t,e)}},"159b":function(t,e,n){var r=n("da84"),i=n("fdbc"),o=n("17c2"),a=n("9112");for(var s in i){var c=r[s],u=c&&c.prototype;if(u&&u.forEach!==o)try{a(u,"forEach",o)}catch(l){u.forEach=o}}},"17c2":function(t,e,n){"use strict";var r=n("b727").forEach,i=n("a640"),o=i("forEach");t.exports=o?[].forEach:function(t){return r(this,t,arguments.length>1?arguments[1]:void 0)}},"18a5":function(t,e,n){"use strict";var r=n("23e7"),i=n("857a"),o=n("af03");r({target:"String",proto:!0,forced:o("anchor")},{anchor:function(t){return i(this,"a","name",t)}})},"19aa":function(t,e){t.exports=function(t,e,n){if(!(t instanceof e))throw TypeError("Incorrect "+(n?n+" ":"")+"invocation");return t}},"1be4":function(t,e,n){var r=n("d066");t.exports=r("document","documentElement")},"1c0b":function(t,e){t.exports=function(t){if("function"!=typeof t)throw TypeError(String(t)+" is not a function");return t}},"1c7e":function(t,e,n){var r=n("b622"),i=r("iterator"),o=!1;try{var a=0,s={next:function(){return{done:!!a++}},return:function(){o=!0}};s[i]=function(){return this},Array.from(s,(function(){throw 2}))}catch(c){}t.exports=function(t,e){if(!e&&!o)return!1;var n=!1;try{var r={};r[i]=function(){return{next:function(){return{done:n=!0}}}},t(r)}catch(c){}return n}},"1cdc":function(t,e,n){var r=n("342f");t.exports=/(?:iphone|ipod|ipad).*applewebkit/i.test(r)},"1d2b":function(t,e,n){"use strict";t.exports=function(t,e){return function(){for(var n=new Array(arguments.length),r=0;r=51||!r((function(){var e=[],n=e.constructor={};return n[a]=function(){return{foo:1}},1!==e[t](Boolean).foo}))}},"20f6":function(t,e,n){},2266:function(t,e,n){var r=n("825a"),i=n("e95a"),o=n("50c4"),a=n("0366"),s=n("35a1"),c=n("2a62"),u=function(t,e){this.stopped=t,this.result=e};t.exports=function(t,e,n){var l,f,d,p,h,v,m,g=n&&n.that,b=!(!n||!n.AS_ENTRIES),y=!(!n||!n.IS_ITERATOR),x=!(!n||!n.INTERRUPTED),w=a(e,g,1+b+x),_=function(t){return l&&c(l),new u(!0,t)},S=function(t){return b?(r(t),x?w(t[0],t[1],_):w(t[0],t[1])):x?w(t,_):w(t)};if(y)l=t;else{if(f=s(t),"function"!=typeof f)throw TypeError("Target is not iterable");if(i(f)){for(d=0,p=o(t.length);p>d;d++)if(h=S(t[d]),h&&h instanceof u)return h;return new u(!1)}l=f.call(t)}v=l.next;while(!(m=v.call(l)).done){try{h=S(m.value)}catch(O){throw c(l),O}if("object"==typeof h&&h&&h instanceof u)return h}return new u(!1)}},"23cb":function(t,e,n){var r=n("a691"),i=Math.max,o=Math.min;t.exports=function(t,e){var n=r(t);return n<0?i(n+e,0):o(n,e)}},"23e7":function(t,e,n){var r=n("da84"),i=n("06cf").f,o=n("9112"),a=n("6eeb"),s=n("ce4e"),c=n("e893"),u=n("94ca");t.exports=function(t,e){var n,l,f,d,p,h,v=t.target,m=t.global,g=t.stat;if(l=m?r:g?r[v]||s(v,{}):(r[v]||{}).prototype,l)for(f in e){if(p=e[f],t.noTargetGet?(h=i(l,f),d=h&&h.value):d=l[f],n=u(m?f:v+(g?".":"#")+f,t.forced),!n&&void 0!==d){if(typeof p===typeof d)continue;c(p,d)}(t.sham||d&&d.sham)&&o(p,"sham",!0),a(l,f,p,t)}}},"241c":function(t,e,n){var r=n("ca84"),i=n("7839"),o=i.concat("length","prototype");e.f=Object.getOwnPropertyNames||function(t){return r(t,o)}},2444:function(t,e,n){"use strict";(function(e){var r=n("c532"),i=n("c8af"),o={"Content-Type":"application/x-www-form-urlencoded"};function a(t,e){!r.isUndefined(t)&&r.isUndefined(t["Content-Type"])&&(t["Content-Type"]=e)}function s(){var t;return("undefined"!==typeof XMLHttpRequest||"undefined"!==typeof e)&&(t=n("b50d")),t}var c={adapter:s(),transformRequest:[function(t,e){return i(e,"Content-Type"),r.isFormData(t)||r.isArrayBuffer(t)||r.isBuffer(t)||r.isStream(t)||r.isFile(t)||r.isBlob(t)?t:r.isArrayBufferView(t)?t.buffer:r.isURLSearchParams(t)?(a(e,"application/x-www-form-urlencoded;charset=utf-8"),t.toString()):r.isObject(t)?(a(e,"application/json;charset=utf-8"),JSON.stringify(t)):t}],transformResponse:[function(t){if("string"===typeof t)try{t=JSON.parse(t)}catch(e){}return t}],timeout:0,xsrfCookieName:"XSRF-TOKEN",xsrfHeaderName:"X-XSRF-TOKEN",maxContentLength:-1,validateStatus:function(t){return t>=200&&t<300},headers:{common:{Accept:"application/json, text/plain, */*"}}};r.forEach(["delete","get","head"],(function(t){c.headers[t]={}})),r.forEach(["post","put","patch"],(function(t){c.headers[t]=r.merge(o)})),t.exports=c}).call(this,n("f28c"))},"24b2":function(t,e,n){"use strict";n("a9e3");var r=n("80d2"),i=n("2b0e");e["a"]=i["a"].extend({name:"measurable",props:{height:[Number,String],maxHeight:[Number,String],maxWidth:[Number,String],minHeight:[Number,String],minWidth:[Number,String],width:[Number,String]},computed:{measurableStyles:function(){var t={},e=Object(r["d"])(this.height),n=Object(r["d"])(this.minHeight),i=Object(r["d"])(this.minWidth),o=Object(r["d"])(this.maxHeight),a=Object(r["d"])(this.maxWidth),s=Object(r["d"])(this.width);return e&&(t.height=e),n&&(t.minHeight=n),i&&(t.minWidth=i),o&&(t.maxHeight=o),a&&(t.maxWidth=a),s&&(t.width=s),t}}})},2532:function(t,e,n){"use strict";var r=n("23e7"),i=n("5a34"),o=n("1d80"),a=n("ab13");r({target:"String",proto:!0,forced:!a("includes")},{includes:function(t){return!!~String(o(this)).indexOf(i(t),arguments.length>1?arguments[1]:void 0)}})},"25a8":function(t,e,n){},"25f0":function(t,e,n){"use strict";var r=n("6eeb"),i=n("825a"),o=n("d039"),a=n("ad6d"),s="toString",c=RegExp.prototype,u=c[s],l=o((function(){return"/a/b"!=u.call({source:"a",flags:"b"})})),f=u.name!=s;(l||f)&&r(RegExp.prototype,s,(function(){var t=i(this),e=String(t.source),n=t.flags,r=String(void 0===n&&t instanceof RegExp&&!("flags"in c)?a.call(t):n);return"/"+e+"/"+r}),{unsafe:!0})},2626:function(t,e,n){"use strict";var r=n("d066"),i=n("9bf2"),o=n("b622"),a=n("83ab"),s=o("species");t.exports=function(t){var e=r(t),n=i.f;a&&e&&!e[s]&&n(e,s,{configurable:!0,get:function(){return this}})}},2877:function(t,e,n){"use strict";function r(t,e,n,r,i,o,a,s){var c,u="function"===typeof t?t.options:t;if(e&&(u.render=e,u.staticRenderFns=n,u._compiled=!0),r&&(u.functional=!0),o&&(u._scopeId="data-v-"+o),a?(c=function(t){t=t||this.$vnode&&this.$vnode.ssrContext||this.parent&&this.parent.$vnode&&this.parent.$vnode.ssrContext,t||"undefined"===typeof __VUE_SSR_CONTEXT__||(t=__VUE_SSR_CONTEXT__),i&&i.call(this,t),t&&t._registeredComponents&&t._registeredComponents.add(a)},u._ssrRegister=c):i&&(c=s?function(){i.call(this,(u.functional?this.parent:this).$root.$options.shadowRoot)}:i),c)if(u.functional){u._injectStyles=c;var l=u.render;u.render=function(t,e){return c.call(e),l(t,e)}}else{var f=u.beforeCreate;u.beforeCreate=f?[].concat(f,c):[c]}return{exports:t,options:u}}n.d(e,"a",(function(){return r}))},"2a62":function(t,e,n){var r=n("825a");t.exports=function(t){var e=t["return"];if(void 0!==e)return r(e.call(t)).value}},"2b0e":function(t,e,n){"use strict";(function(t){ -/*! - * Vue.js v2.6.12 - * (c) 2014-2020 Evan You - * Released under the MIT License. - */ -var n=Object.freeze({});function r(t){return void 0===t||null===t}function i(t){return void 0!==t&&null!==t}function o(t){return!0===t}function a(t){return!1===t}function s(t){return"string"===typeof t||"number"===typeof t||"symbol"===typeof t||"boolean"===typeof t}function c(t){return null!==t&&"object"===typeof t}var u=Object.prototype.toString;function l(t){return"[object Object]"===u.call(t)}function f(t){return"[object RegExp]"===u.call(t)}function d(t){var e=parseFloat(String(t));return e>=0&&Math.floor(e)===e&&isFinite(t)}function p(t){return i(t)&&"function"===typeof t.then&&"function"===typeof t.catch}function h(t){return null==t?"":Array.isArray(t)||l(t)&&t.toString===u?JSON.stringify(t,null,2):String(t)}function v(t){var e=parseFloat(t);return isNaN(e)?t:e}function m(t,e){for(var n=Object.create(null),r=t.split(","),i=0;i-1)return t.splice(n,1)}}var y=Object.prototype.hasOwnProperty;function x(t,e){return y.call(t,e)}function w(t){var e=Object.create(null);return function(n){var r=e[n];return r||(e[n]=t(n))}}var _=/-(\w)/g,S=w((function(t){return t.replace(_,(function(t,e){return e?e.toUpperCase():""}))})),O=w((function(t){return t.charAt(0).toUpperCase()+t.slice(1)})),C=/\B([A-Z])/g,k=w((function(t){return t.replace(C,"-$1").toLowerCase()}));function j(t,e){function n(n){var r=arguments.length;return r?r>1?t.apply(e,arguments):t.call(e,n):t.call(e)}return n._length=t.length,n}function L(t,e){return t.bind(e)}var E=Function.prototype.bind?L:j;function A(t,e){e=e||0;var n=t.length-e,r=new Array(n);while(n--)r[n]=t[n+e];return r}function $(t,e){for(var n in e)t[n]=e[n];return t}function T(t){for(var e={},n=0;n0,nt=J&&J.indexOf("edge/")>0,rt=(J&&J.indexOf("android"),J&&/iphone|ipad|ipod|ios/.test(J)||"ios"===Q),it=(J&&/chrome\/\d+/.test(J),J&&/phantomjs/.test(J),J&&J.match(/firefox\/(\d+)/)),ot={}.watch,at=!1;if(X)try{var st={};Object.defineProperty(st,"passive",{get:function(){at=!0}}),window.addEventListener("test-passive",null,st)}catch(Sa){}var ct=function(){return void 0===G&&(G=!X&&!Y&&"undefined"!==typeof t&&(t["process"]&&"server"===t["process"].env.VUE_ENV)),G},ut=X&&window.__VUE_DEVTOOLS_GLOBAL_HOOK__;function lt(t){return"function"===typeof t&&/native code/.test(t.toString())}var ft,dt="undefined"!==typeof Symbol&<(Symbol)&&"undefined"!==typeof Reflect&<(Reflect.ownKeys);ft="undefined"!==typeof Set&<(Set)?Set:function(){function t(){this.set=Object.create(null)}return t.prototype.has=function(t){return!0===this.set[t]},t.prototype.add=function(t){this.set[t]=!0},t.prototype.clear=function(){this.set=Object.create(null)},t}();var pt=P,ht=0,vt=function(){this.id=ht++,this.subs=[]};vt.prototype.addSub=function(t){this.subs.push(t)},vt.prototype.removeSub=function(t){b(this.subs,t)},vt.prototype.depend=function(){vt.target&&vt.target.addDep(this)},vt.prototype.notify=function(){var t=this.subs.slice();for(var e=0,n=t.length;e-1)if(o&&!x(i,"default"))a=!1;else if(""===a||a===k(t)){var c=te(String,i.type);(c<0||s0&&(a=je(a,(e||"")+"_"+n),ke(a[0])&&ke(u)&&(l[c]=_t(u.text+a[0].text),a.shift()),l.push.apply(l,a)):s(a)?ke(u)?l[c]=_t(u.text+a):""!==a&&l.push(_t(a)):ke(a)&&ke(u)?l[c]=_t(u.text+a.text):(o(t._isVList)&&i(a.tag)&&r(a.key)&&i(e)&&(a.key="__vlist"+e+"_"+n+"__"),l.push(a)));return l}function Le(t){var e=t.$options.provide;e&&(t._provided="function"===typeof e?e.call(t):e)}function Ee(t){var e=Ae(t.$options.inject,t);e&&(Et(!1),Object.keys(e).forEach((function(n){Mt(t,n,e[n])})),Et(!0))}function Ae(t,e){if(t){for(var n=Object.create(null),r=dt?Reflect.ownKeys(t):Object.keys(t),i=0;i0,a=t?!!t.$stable:!o,s=t&&t.$key;if(t){if(t._normalized)return t._normalized;if(a&&r&&r!==n&&s===r.$key&&!o&&!r.$hasNormal)return r;for(var c in i={},t)t[c]&&"$"!==c[0]&&(i[c]=Me(e,c,t[c]))}else i={};for(var u in e)u in i||(i[u]=Ie(e,u));return t&&Object.isExtensible(t)&&(t._normalized=i),W(i,"$stable",a),W(i,"$key",s),W(i,"$hasNormal",o),i}function Me(t,e,n){var r=function(){var t=arguments.length?n.apply(null,arguments):n({});return t=t&&"object"===typeof t&&!Array.isArray(t)?[t]:Ce(t),t&&(0===t.length||1===t.length&&t[0].isComment)?void 0:t};return n.proxy&&Object.defineProperty(t,e,{get:r,enumerable:!0,configurable:!0}),r}function Ie(t,e){return function(){return t[e]}}function Ne(t,e){var n,r,o,a,s;if(Array.isArray(t)||"string"===typeof t)for(n=new Array(t.length),r=0,o=t.length;r1?A(n):n;for(var r=A(arguments,1),i='event handler for "'+t+'"',o=0,a=n.length;odocument.createEvent("Event").timeStamp&&(Gn=function(){return Kn.now()})}function Xn(){var t,e;for(Zn=Gn(),Un=!0,Fn.sort((function(t,e){return t.id-e.id})),Wn=0;WnWn&&Fn[n].id>t.id)n--;Fn.splice(n+1,0,t)}else Fn.push(t);Vn||(Vn=!0,he(Xn))}}var er=0,nr=function(t,e,n,r,i){this.vm=t,i&&(t._watcher=this),t._watchers.push(this),r?(this.deep=!!r.deep,this.user=!!r.user,this.lazy=!!r.lazy,this.sync=!!r.sync,this.before=r.before):this.deep=this.user=this.lazy=this.sync=!1,this.cb=n,this.id=++er,this.active=!0,this.dirty=this.lazy,this.deps=[],this.newDeps=[],this.depIds=new ft,this.newDepIds=new ft,this.expression="","function"===typeof e?this.getter=e:(this.getter=Z(e),this.getter||(this.getter=P)),this.value=this.lazy?void 0:this.get()};nr.prototype.get=function(){var t;gt(this);var e=this.vm;try{t=this.getter.call(e,e)}catch(Sa){if(!this.user)throw Sa;ee(Sa,e,'getter for watcher "'+this.expression+'"')}finally{this.deep&&me(t),bt(),this.cleanupDeps()}return t},nr.prototype.addDep=function(t){var e=t.id;this.newDepIds.has(e)||(this.newDepIds.add(e),this.newDeps.push(t),this.depIds.has(e)||t.addSub(this))},nr.prototype.cleanupDeps=function(){var t=this.deps.length;while(t--){var e=this.deps[t];this.newDepIds.has(e.id)||e.removeSub(this)}var n=this.depIds;this.depIds=this.newDepIds,this.newDepIds=n,this.newDepIds.clear(),n=this.deps,this.deps=this.newDeps,this.newDeps=n,this.newDeps.length=0},nr.prototype.update=function(){this.lazy?this.dirty=!0:this.sync?this.run():tr(this)},nr.prototype.run=function(){if(this.active){var t=this.get();if(t!==this.value||c(t)||this.deep){var e=this.value;if(this.value=t,this.user)try{this.cb.call(this.vm,t,e)}catch(Sa){ee(Sa,this.vm,'callback for watcher "'+this.expression+'"')}else this.cb.call(this.vm,t,e)}}},nr.prototype.evaluate=function(){this.value=this.get(),this.dirty=!1},nr.prototype.depend=function(){var t=this.deps.length;while(t--)this.deps[t].depend()},nr.prototype.teardown=function(){if(this.active){this.vm._isBeingDestroyed||b(this.vm._watchers,this);var t=this.deps.length;while(t--)this.deps[t].removeSub(this);this.active=!1}};var rr={enumerable:!0,configurable:!0,get:P,set:P};function ir(t,e,n){rr.get=function(){return this[e][n]},rr.set=function(t){this[e][n]=t},Object.defineProperty(t,n,rr)}function or(t){t._watchers=[];var e=t.$options;e.props&&ar(t,e.props),e.methods&&hr(t,e.methods),e.data?sr(t):Pt(t._data={},!0),e.computed&&lr(t,e.computed),e.watch&&e.watch!==ot&&vr(t,e.watch)}function ar(t,e){var n=t.$options.propsData||{},r=t._props={},i=t.$options._propKeys=[],o=!t.$parent;o||Et(!1);var a=function(o){i.push(o);var a=Xt(o,e,n,t);Mt(r,o,a),o in t||ir(t,"_props",o)};for(var s in e)a(s);Et(!0)}function sr(t){var e=t.$options.data;e=t._data="function"===typeof e?cr(e,t):e||{},l(e)||(e={});var n=Object.keys(e),r=t.$options.props,i=(t.$options.methods,n.length);while(i--){var o=n[i];0,r&&x(r,o)||U(o)||ir(t,"_data",o)}Pt(e,!0)}function cr(t,e){gt();try{return t.call(e,e)}catch(Sa){return ee(Sa,e,"data()"),{}}finally{bt()}}var ur={lazy:!0};function lr(t,e){var n=t._computedWatchers=Object.create(null),r=ct();for(var i in e){var o=e[i],a="function"===typeof o?o:o.get;0,r||(n[i]=new nr(t,a||P,P,ur)),i in t||fr(t,i,o)}}function fr(t,e,n){var r=!ct();"function"===typeof n?(rr.get=r?dr(e):pr(n),rr.set=P):(rr.get=n.get?r&&!1!==n.cache?dr(e):pr(n.get):P,rr.set=n.set||P),Object.defineProperty(t,e,rr)}function dr(t){return function(){var e=this._computedWatchers&&this._computedWatchers[t];if(e)return e.dirty&&e.evaluate(),vt.target&&e.depend(),e.value}}function pr(t){return function(){return t.call(this,this)}}function hr(t,e){t.$options.props;for(var n in e)t[n]="function"!==typeof e[n]?P:E(e[n],t)}function vr(t,e){for(var n in e){var r=e[n];if(Array.isArray(r))for(var i=0;i-1)return this;var n=A(arguments,1);return n.unshift(this),"function"===typeof t.install?t.install.apply(t,n):"function"===typeof t&&t.apply(null,n),e.push(t),this}}function Cr(t){t.mixin=function(t){return this.options=Gt(this.options,t),this}}function kr(t){t.cid=0;var e=1;t.extend=function(t){t=t||{};var n=this,r=n.cid,i=t._Ctor||(t._Ctor={});if(i[r])return i[r];var o=t.name||n.options.name;var a=function(t){this._init(t)};return a.prototype=Object.create(n.prototype),a.prototype.constructor=a,a.cid=e++,a.options=Gt(n.options,t),a["super"]=n,a.options.props&&jr(a),a.options.computed&&Lr(a),a.extend=n.extend,a.mixin=n.mixin,a.use=n.use,F.forEach((function(t){a[t]=n[t]})),o&&(a.options.components[o]=a),a.superOptions=n.options,a.extendOptions=t,a.sealedOptions=$({},a.options),i[r]=a,a}}function jr(t){var e=t.options.props;for(var n in e)ir(t.prototype,"_props",n)}function Lr(t){var e=t.options.computed;for(var n in e)fr(t.prototype,n,e[n])}function Er(t){F.forEach((function(e){t[e]=function(t,n){return n?("component"===e&&l(n)&&(n.name=n.name||t,n=this.options._base.extend(n)),"directive"===e&&"function"===typeof n&&(n={bind:n,update:n}),this.options[e+"s"][t]=n,n):this.options[e+"s"][t]}}))}function Ar(t){return t&&(t.Ctor.options.name||t.tag)}function $r(t,e){return Array.isArray(t)?t.indexOf(e)>-1:"string"===typeof t?t.split(",").indexOf(e)>-1:!!f(t)&&t.test(e)}function Tr(t,e){var n=t.cache,r=t.keys,i=t._vnode;for(var o in n){var a=n[o];if(a){var s=Ar(a.componentOptions);s&&!e(s)&&Pr(n,o,r,i)}}}function Pr(t,e,n,r){var i=t[e];!i||r&&i.tag===r.tag||i.componentInstance.$destroy(),t[e]=null,b(n,e)}yr(Sr),gr(Sr),En(Sr),Pn(Sr),bn(Sr);var Mr=[String,RegExp,Array],Ir={name:"keep-alive",abstract:!0,props:{include:Mr,exclude:Mr,max:[String,Number]},created:function(){this.cache=Object.create(null),this.keys=[]},destroyed:function(){for(var t in this.cache)Pr(this.cache,t,this.keys)},mounted:function(){var t=this;this.$watch("include",(function(e){Tr(t,(function(t){return $r(e,t)}))})),this.$watch("exclude",(function(e){Tr(t,(function(t){return!$r(e,t)}))}))},render:function(){var t=this.$slots.default,e=Sn(t),n=e&&e.componentOptions;if(n){var r=Ar(n),i=this,o=i.include,a=i.exclude;if(o&&(!r||!$r(o,r))||a&&r&&$r(a,r))return e;var s=this,c=s.cache,u=s.keys,l=null==e.key?n.Ctor.cid+(n.tag?"::"+n.tag:""):e.key;c[l]?(e.componentInstance=c[l].componentInstance,b(u,l),u.push(l)):(c[l]=e,u.push(l),this.max&&u.length>parseInt(this.max)&&Pr(c,u[0],u,this._vnode)),e.data.keepAlive=!0}return e||t&&t[0]}},Nr={KeepAlive:Ir};function Br(t){var e={get:function(){return z}};Object.defineProperty(t,"config",e),t.util={warn:pt,extend:$,mergeOptions:Gt,defineReactive:Mt},t.set=It,t.delete=Nt,t.nextTick=he,t.observable=function(t){return Pt(t),t},t.options=Object.create(null),F.forEach((function(e){t.options[e+"s"]=Object.create(null)})),t.options._base=t,$(t.options.components,Nr),Or(t),Cr(t),kr(t),Er(t)}Br(Sr),Object.defineProperty(Sr.prototype,"$isServer",{get:ct}),Object.defineProperty(Sr.prototype,"$ssrContext",{get:function(){return this.$vnode&&this.$vnode.ssrContext}}),Object.defineProperty(Sr,"FunctionalRenderContext",{value:Ye}),Sr.version="2.6.12";var Rr=m("style,class"),Dr=m("input,textarea,option,select,progress"),Fr=function(t,e,n){return"value"===n&&Dr(t)&&"button"!==e||"selected"===n&&"option"===t||"checked"===n&&"input"===t||"muted"===n&&"video"===t},Hr=m("contenteditable,draggable,spellcheck"),zr=m("events,caret,typing,plaintext-only"),Vr=function(t,e){return Gr(e)||"false"===e?"false":"contenteditable"===t&&zr(e)?e:"true"},Ur=m("allowfullscreen,async,autofocus,autoplay,checked,compact,controls,declare,default,defaultchecked,defaultmuted,defaultselected,defer,disabled,enabled,formnovalidate,hidden,indeterminate,inert,ismap,itemscope,loop,multiple,muted,nohref,noresize,noshade,novalidate,nowrap,open,pauseonexit,readonly,required,reversed,scoped,seamless,selected,sortable,translate,truespeed,typemustmatch,visible"),Wr="http://www.w3.org/1999/xlink",qr=function(t){return":"===t.charAt(5)&&"xlink"===t.slice(0,5)},Zr=function(t){return qr(t)?t.slice(6,t.length):""},Gr=function(t){return null==t||!1===t};function Kr(t){var e=t.data,n=t,r=t;while(i(r.componentInstance))r=r.componentInstance._vnode,r&&r.data&&(e=Xr(r.data,e));while(i(n=n.parent))n&&n.data&&(e=Xr(e,n.data));return Yr(e.staticClass,e.class)}function Xr(t,e){return{staticClass:Qr(t.staticClass,e.staticClass),class:i(t.class)?[t.class,e.class]:e.class}}function Yr(t,e){return i(t)||i(e)?Qr(t,Jr(e)):""}function Qr(t,e){return t?e?t+" "+e:t:e||""}function Jr(t){return Array.isArray(t)?ti(t):c(t)?ei(t):"string"===typeof t?t:""}function ti(t){for(var e,n="",r=0,o=t.length;r-1?si[t]=e.constructor===window.HTMLUnknownElement||e.constructor===window.HTMLElement:si[t]=/HTMLUnknownElement/.test(e.toString())}var ui=m("text,number,password,search,email,tel,url");function li(t){if("string"===typeof t){var e=document.querySelector(t);return e||document.createElement("div")}return t}function fi(t,e){var n=document.createElement(t);return"select"!==t||e.data&&e.data.attrs&&void 0!==e.data.attrs.multiple&&n.setAttribute("multiple","multiple"),n}function di(t,e){return document.createElementNS(ni[t],e)}function pi(t){return document.createTextNode(t)}function hi(t){return document.createComment(t)}function vi(t,e,n){t.insertBefore(e,n)}function mi(t,e){t.removeChild(e)}function gi(t,e){t.appendChild(e)}function bi(t){return t.parentNode}function yi(t){return t.nextSibling}function xi(t){return t.tagName}function wi(t,e){t.textContent=e}function _i(t,e){t.setAttribute(e,"")}var Si=Object.freeze({createElement:fi,createElementNS:di,createTextNode:pi,createComment:hi,insertBefore:vi,removeChild:mi,appendChild:gi,parentNode:bi,nextSibling:yi,tagName:xi,setTextContent:wi,setStyleScope:_i}),Oi={create:function(t,e){Ci(e)},update:function(t,e){t.data.ref!==e.data.ref&&(Ci(t,!0),Ci(e))},destroy:function(t){Ci(t,!0)}};function Ci(t,e){var n=t.data.ref;if(i(n)){var r=t.context,o=t.componentInstance||t.elm,a=r.$refs;e?Array.isArray(a[n])?b(a[n],o):a[n]===o&&(a[n]=void 0):t.data.refInFor?Array.isArray(a[n])?a[n].indexOf(o)<0&&a[n].push(o):a[n]=[o]:a[n]=o}}var ki=new yt("",{},[]),ji=["create","activate","update","remove","destroy"];function Li(t,e){return t.key===e.key&&(t.tag===e.tag&&t.isComment===e.isComment&&i(t.data)===i(e.data)&&Ei(t,e)||o(t.isAsyncPlaceholder)&&t.asyncFactory===e.asyncFactory&&r(e.asyncFactory.error))}function Ei(t,e){if("input"!==t.tag)return!0;var n,r=i(n=t.data)&&i(n=n.attrs)&&n.type,o=i(n=e.data)&&i(n=n.attrs)&&n.type;return r===o||ui(r)&&ui(o)}function Ai(t,e,n){var r,o,a={};for(r=e;r<=n;++r)o=t[r].key,i(o)&&(a[o]=r);return a}function $i(t){var e,n,a={},c=t.modules,u=t.nodeOps;for(e=0;ev?(f=r(n[b+1])?null:n[b+1].elm,S(t,f,n,h,b,o)):h>b&&C(e,d,v)}function L(t,e,n,r){for(var o=n;o-1?zi(t,e,n):Ur(e)?Gr(n)?t.removeAttribute(e):(n="allowfullscreen"===e&&"EMBED"===t.tagName?"true":e,t.setAttribute(e,n)):Hr(e)?t.setAttribute(e,Vr(e,n)):qr(e)?Gr(n)?t.removeAttributeNS(Wr,Zr(e)):t.setAttributeNS(Wr,e,n):zi(t,e,n)}function zi(t,e,n){if(Gr(n))t.removeAttribute(e);else{if(tt&&!et&&"TEXTAREA"===t.tagName&&"placeholder"===e&&""!==n&&!t.__ieph){var r=function(e){e.stopImmediatePropagation(),t.removeEventListener("input",r)};t.addEventListener("input",r),t.__ieph=!0}t.setAttribute(e,n)}}var Vi={create:Fi,update:Fi};function Ui(t,e){var n=e.elm,o=e.data,a=t.data;if(!(r(o.staticClass)&&r(o.class)&&(r(a)||r(a.staticClass)&&r(a.class)))){var s=Kr(e),c=n._transitionClasses;i(c)&&(s=Qr(s,Jr(c))),s!==n._prevClass&&(n.setAttribute("class",s),n._prevClass=s)}}var Wi,qi={create:Ui,update:Ui},Zi="__r",Gi="__c";function Ki(t){if(i(t[Zi])){var e=tt?"change":"input";t[e]=[].concat(t[Zi],t[e]||[]),delete t[Zi]}i(t[Gi])&&(t.change=[].concat(t[Gi],t.change||[]),delete t[Gi])}function Xi(t,e,n){var r=Wi;return function i(){var o=e.apply(null,arguments);null!==o&&Ji(t,i,n,r)}}var Yi=ae&&!(it&&Number(it[1])<=53);function Qi(t,e,n,r){if(Yi){var i=Zn,o=e;e=o._wrapper=function(t){if(t.target===t.currentTarget||t.timeStamp>=i||t.timeStamp<=0||t.target.ownerDocument!==document)return o.apply(this,arguments)}}Wi.addEventListener(t,e,at?{capture:n,passive:r}:n)}function Ji(t,e,n,r){(r||Wi).removeEventListener(t,e._wrapper||e,n)}function to(t,e){if(!r(t.data.on)||!r(e.data.on)){var n=e.data.on||{},i=t.data.on||{};Wi=e.elm,Ki(n),xe(n,i,Qi,Ji,Xi,e.context),Wi=void 0}}var eo,no={create:to,update:to};function ro(t,e){if(!r(t.data.domProps)||!r(e.data.domProps)){var n,o,a=e.elm,s=t.data.domProps||{},c=e.data.domProps||{};for(n in i(c.__ob__)&&(c=e.data.domProps=$({},c)),s)n in c||(a[n]="");for(n in c){if(o=c[n],"textContent"===n||"innerHTML"===n){if(e.children&&(e.children.length=0),o===s[n])continue;1===a.childNodes.length&&a.removeChild(a.childNodes[0])}if("value"===n&&"PROGRESS"!==a.tagName){a._value=o;var u=r(o)?"":String(o);io(a,u)&&(a.value=u)}else if("innerHTML"===n&&ii(a.tagName)&&r(a.innerHTML)){eo=eo||document.createElement("div"),eo.innerHTML=""+o+"";var l=eo.firstChild;while(a.firstChild)a.removeChild(a.firstChild);while(l.firstChild)a.appendChild(l.firstChild)}else if(o!==s[n])try{a[n]=o}catch(Sa){}}}}function io(t,e){return!t.composing&&("OPTION"===t.tagName||oo(t,e)||ao(t,e))}function oo(t,e){var n=!0;try{n=document.activeElement!==t}catch(Sa){}return n&&t.value!==e}function ao(t,e){var n=t.value,r=t._vModifiers;if(i(r)){if(r.number)return v(n)!==v(e);if(r.trim)return n.trim()!==e.trim()}return n!==e}var so={create:ro,update:ro},co=w((function(t){var e={},n=/;(?![^(]*\))/g,r=/:(.+)/;return t.split(n).forEach((function(t){if(t){var n=t.split(r);n.length>1&&(e[n[0].trim()]=n[1].trim())}})),e}));function uo(t){var e=lo(t.style);return t.staticStyle?$(t.staticStyle,e):e}function lo(t){return Array.isArray(t)?T(t):"string"===typeof t?co(t):t}function fo(t,e){var n,r={};if(e){var i=t;while(i.componentInstance)i=i.componentInstance._vnode,i&&i.data&&(n=uo(i.data))&&$(r,n)}(n=uo(t.data))&&$(r,n);var o=t;while(o=o.parent)o.data&&(n=uo(o.data))&&$(r,n);return r}var po,ho=/^--/,vo=/\s*!important$/,mo=function(t,e,n){if(ho.test(e))t.style.setProperty(e,n);else if(vo.test(n))t.style.setProperty(k(e),n.replace(vo,""),"important");else{var r=bo(e);if(Array.isArray(n))for(var i=0,o=n.length;i-1?e.split(wo).forEach((function(e){return t.classList.add(e)})):t.classList.add(e);else{var n=" "+(t.getAttribute("class")||"")+" ";n.indexOf(" "+e+" ")<0&&t.setAttribute("class",(n+e).trim())}}function So(t,e){if(e&&(e=e.trim()))if(t.classList)e.indexOf(" ")>-1?e.split(wo).forEach((function(e){return t.classList.remove(e)})):t.classList.remove(e),t.classList.length||t.removeAttribute("class");else{var n=" "+(t.getAttribute("class")||"")+" ",r=" "+e+" ";while(n.indexOf(r)>=0)n=n.replace(r," ");n=n.trim(),n?t.setAttribute("class",n):t.removeAttribute("class")}}function Oo(t){if(t){if("object"===typeof t){var e={};return!1!==t.css&&$(e,Co(t.name||"v")),$(e,t),e}return"string"===typeof t?Co(t):void 0}}var Co=w((function(t){return{enterClass:t+"-enter",enterToClass:t+"-enter-to",enterActiveClass:t+"-enter-active",leaveClass:t+"-leave",leaveToClass:t+"-leave-to",leaveActiveClass:t+"-leave-active"}})),ko=X&&!et,jo="transition",Lo="animation",Eo="transition",Ao="transitionend",$o="animation",To="animationend";ko&&(void 0===window.ontransitionend&&void 0!==window.onwebkittransitionend&&(Eo="WebkitTransition",Ao="webkitTransitionEnd"),void 0===window.onanimationend&&void 0!==window.onwebkitanimationend&&($o="WebkitAnimation",To="webkitAnimationEnd"));var Po=X?window.requestAnimationFrame?window.requestAnimationFrame.bind(window):setTimeout:function(t){return t()};function Mo(t){Po((function(){Po(t)}))}function Io(t,e){var n=t._transitionClasses||(t._transitionClasses=[]);n.indexOf(e)<0&&(n.push(e),_o(t,e))}function No(t,e){t._transitionClasses&&b(t._transitionClasses,e),So(t,e)}function Bo(t,e,n){var r=Do(t,e),i=r.type,o=r.timeout,a=r.propCount;if(!i)return n();var s=i===jo?Ao:To,c=0,u=function(){t.removeEventListener(s,l),n()},l=function(e){e.target===t&&++c>=a&&u()};setTimeout((function(){c0&&(n=jo,l=a,f=o.length):e===Lo?u>0&&(n=Lo,l=u,f=c.length):(l=Math.max(a,u),n=l>0?a>u?jo:Lo:null,f=n?n===jo?o.length:c.length:0);var d=n===jo&&Ro.test(r[Eo+"Property"]);return{type:n,timeout:l,propCount:f,hasTransform:d}}function Fo(t,e){while(t.length1}function qo(t,e){!0!==e.data.show&&zo(e)}var Zo=X?{create:qo,activate:qo,remove:function(t,e){!0!==t.data.show?Vo(t,e):e()}}:{},Go=[Vi,qi,no,so,xo,Zo],Ko=Go.concat(Di),Xo=$i({nodeOps:Si,modules:Ko});et&&document.addEventListener("selectionchange",(function(){var t=document.activeElement;t&&t.vmodel&&ia(t,"input")}));var Yo={inserted:function(t,e,n,r){"select"===n.tag?(r.elm&&!r.elm._vOptions?we(n,"postpatch",(function(){Yo.componentUpdated(t,e,n)})):Qo(t,e,n.context),t._vOptions=[].map.call(t.options,ea)):("textarea"===n.tag||ui(t.type))&&(t._vModifiers=e.modifiers,e.modifiers.lazy||(t.addEventListener("compositionstart",na),t.addEventListener("compositionend",ra),t.addEventListener("change",ra),et&&(t.vmodel=!0)))},componentUpdated:function(t,e,n){if("select"===n.tag){Qo(t,e,n.context);var r=t._vOptions,i=t._vOptions=[].map.call(t.options,ea);if(i.some((function(t,e){return!N(t,r[e])}))){var o=t.multiple?e.value.some((function(t){return ta(t,i)})):e.value!==e.oldValue&&ta(e.value,i);o&&ia(t,"change")}}}};function Qo(t,e,n){Jo(t,e,n),(tt||nt)&&setTimeout((function(){Jo(t,e,n)}),0)}function Jo(t,e,n){var r=e.value,i=t.multiple;if(!i||Array.isArray(r)){for(var o,a,s=0,c=t.options.length;s-1,a.selected!==o&&(a.selected=o);else if(N(ea(a),r))return void(t.selectedIndex!==s&&(t.selectedIndex=s));i||(t.selectedIndex=-1)}}function ta(t,e){return e.every((function(e){return!N(e,t)}))}function ea(t){return"_value"in t?t._value:t.value}function na(t){t.target.composing=!0}function ra(t){t.target.composing&&(t.target.composing=!1,ia(t.target,"input"))}function ia(t,e){var n=document.createEvent("HTMLEvents");n.initEvent(e,!0,!0),t.dispatchEvent(n)}function oa(t){return!t.componentInstance||t.data&&t.data.transition?t:oa(t.componentInstance._vnode)}var aa={bind:function(t,e,n){var r=e.value;n=oa(n);var i=n.data&&n.data.transition,o=t.__vOriginalDisplay="none"===t.style.display?"":t.style.display;r&&i?(n.data.show=!0,zo(n,(function(){t.style.display=o}))):t.style.display=r?o:"none"},update:function(t,e,n){var r=e.value,i=e.oldValue;if(!r!==!i){n=oa(n);var o=n.data&&n.data.transition;o?(n.data.show=!0,r?zo(n,(function(){t.style.display=t.__vOriginalDisplay})):Vo(n,(function(){t.style.display="none"}))):t.style.display=r?t.__vOriginalDisplay:"none"}},unbind:function(t,e,n,r,i){i||(t.style.display=t.__vOriginalDisplay)}},sa={model:Yo,show:aa},ca={name:String,appear:Boolean,css:Boolean,mode:String,type:String,enterClass:String,leaveClass:String,enterToClass:String,leaveToClass:String,enterActiveClass:String,leaveActiveClass:String,appearClass:String,appearActiveClass:String,appearToClass:String,duration:[Number,String,Object]};function ua(t){var e=t&&t.componentOptions;return e&&e.Ctor.options.abstract?ua(Sn(e.children)):t}function la(t){var e={},n=t.$options;for(var r in n.propsData)e[r]=t[r];var i=n._parentListeners;for(var o in i)e[S(o)]=i[o];return e}function fa(t,e){if(/\d-keep-alive$/.test(e.tag))return t("keep-alive",{props:e.componentOptions.propsData})}function da(t){while(t=t.parent)if(t.data.transition)return!0}function pa(t,e){return e.key===t.key&&e.tag===t.tag}var ha=function(t){return t.tag||_n(t)},va=function(t){return"show"===t.name},ma={name:"transition",props:ca,abstract:!0,render:function(t){var e=this,n=this.$slots.default;if(n&&(n=n.filter(ha),n.length)){0;var r=this.mode;0;var i=n[0];if(da(this.$vnode))return i;var o=ua(i);if(!o)return i;if(this._leaving)return fa(t,i);var a="__transition-"+this._uid+"-";o.key=null==o.key?o.isComment?a+"comment":a+o.tag:s(o.key)?0===String(o.key).indexOf(a)?o.key:a+o.key:o.key;var c=(o.data||(o.data={})).transition=la(this),u=this._vnode,l=ua(u);if(o.data.directives&&o.data.directives.some(va)&&(o.data.show=!0),l&&l.data&&!pa(o,l)&&!_n(l)&&(!l.componentInstance||!l.componentInstance._vnode.isComment)){var f=l.data.transition=$({},c);if("out-in"===r)return this._leaving=!0,we(f,"afterLeave",(function(){e._leaving=!1,e.$forceUpdate()})),fa(t,i);if("in-out"===r){if(_n(o))return u;var d,p=function(){d()};we(c,"afterEnter",p),we(c,"enterCancelled",p),we(f,"delayLeave",(function(t){d=t}))}}return i}}},ga=$({tag:String,moveClass:String},ca);delete ga.mode;var ba={props:ga,beforeMount:function(){var t=this,e=this._update;this._update=function(n,r){var i=$n(t);t.__patch__(t._vnode,t.kept,!1,!0),t._vnode=t.kept,i(),e.call(t,n,r)}},render:function(t){for(var e=this.tag||this.$vnode.data.tag||"span",n=Object.create(null),r=this.prevChildren=this.children,i=this.$slots.default||[],o=this.children=[],a=la(this),s=0;s1?arguments[1]:void 0,e.length)),r=String(t);return l?l.call(e,r,n):e.slice(n,n+r.length)===r}})},"2cf4":function(t,e,n){var r,i,o,a=n("da84"),s=n("d039"),c=n("0366"),u=n("1be4"),l=n("cc12"),f=n("1cdc"),d=n("605d"),p=a.location,h=a.setImmediate,v=a.clearImmediate,m=a.process,g=a.MessageChannel,b=a.Dispatch,y=0,x={},w="onreadystatechange",_=function(t){if(x.hasOwnProperty(t)){var e=x[t];delete x[t],e()}},S=function(t){return function(){_(t)}},O=function(t){_(t.data)},C=function(t){a.postMessage(t+"",p.protocol+"//"+p.host)};h&&v||(h=function(t){var e=[],n=1;while(arguments.length>n)e.push(arguments[n++]);return x[++y]=function(){("function"==typeof t?t:Function(t)).apply(void 0,e)},r(y),y},v=function(t){delete x[t]},d?r=function(t){m.nextTick(S(t))}:b&&b.now?r=function(t){b.now(S(t))}:g&&!f?(i=new g,o=i.port2,i.port1.onmessage=O,r=c(o.postMessage,o,1)):a.addEventListener&&"function"==typeof postMessage&&!a.importScripts&&p&&"file:"!==p.protocol&&!s(C)?(r=C,a.addEventListener("message",O,!1)):r=w in l("script")?function(t){u.appendChild(l("script"))[w]=function(){u.removeChild(this),_(t)}}:function(t){setTimeout(S(t),0)}),t.exports={set:h,clear:v}},"2d00":function(t,e,n){var r,i,o=n("da84"),a=n("342f"),s=o.process,c=s&&s.versions,u=c&&c.v8;u?(r=u.split("."),i=r[0]<4?1:r[0]+r[1]):a&&(r=a.match(/Edge\/(\d+)/),(!r||r[1]>=74)&&(r=a.match(/Chrome\/(\d+)/),r&&(i=r[1]))),t.exports=i&&+i},"2d83":function(t,e,n){"use strict";var r=n("387f");t.exports=function(t,e,n,i,o){var a=new Error(t);return r(a,e,n,i,o)}},"2e67":function(t,e,n){"use strict";t.exports=function(t){return!(!t||!t.__CANCEL__)}},"2fa4":function(t,e,n){"use strict";n("20f6");var r=n("80d2");e["a"]=Object(r["e"])("spacer","div","v-spacer")},"30b5":function(t,e,n){"use strict";var r=n("c532");function i(t){return encodeURIComponent(t).replace(/%40/gi,"@").replace(/%3A/gi,":").replace(/%24/g,"$").replace(/%2C/gi,",").replace(/%20/g,"+").replace(/%5B/gi,"[").replace(/%5D/gi,"]")}t.exports=function(t,e,n){if(!e)return t;var o;if(n)o=n(e);else if(r.isURLSearchParams(e))o=e.toString();else{var a=[];r.forEach(e,(function(t,e){null!==t&&"undefined"!==typeof t&&(r.isArray(t)?e+="[]":t=[t],r.forEach(t,(function(t){r.isDate(t)?t=t.toISOString():r.isObject(t)&&(t=JSON.stringify(t)),a.push(i(e)+"="+i(t))})))})),o=a.join("&")}return o&&(t+=(-1===t.indexOf("?")?"?":"&")+o),t}},3410:function(t,e,n){var r=n("23e7"),i=n("d039"),o=n("7b0b"),a=n("e163"),s=n("e177"),c=i((function(){a(1)}));r({target:"Object",stat:!0,forced:c,sham:!s},{getPrototypeOf:function(t){return a(o(t))}})},"342f":function(t,e,n){var r=n("d066");t.exports=r("navigator","userAgent")||""},"35a1":function(t,e,n){var r=n("f5df"),i=n("3f8c"),o=n("b622"),a=o("iterator");t.exports=function(t){if(void 0!=t)return t[a]||t["@@iterator"]||i[r(t)]}},"36a7":function(t,e,n){},"37e8":function(t,e,n){var r=n("83ab"),i=n("9bf2"),o=n("825a"),a=n("df75");t.exports=r?Object.defineProperties:function(t,e){o(t);var n,r=a(e),s=r.length,c=0;while(s>c)i.f(t,n=r[c++],e[n]);return t}},3835:function(t,e,n){"use strict";function r(t){if(Array.isArray(t))return t}n.d(e,"a",(function(){return s}));n("a4d3"),n("e01a"),n("d3b7"),n("d28b"),n("3ca3"),n("ddb0");function i(t,e){var n=t&&("undefined"!==typeof Symbol&&t[Symbol.iterator]||t["@@iterator"]);if(null!=n){var r,i,o=[],a=!0,s=!1;try{for(n=n.call(t);!(a=(r=n.next()).done);a=!0)if(o.push(r.value),e&&o.length===e)break}catch(c){s=!0,i=c}finally{try{a||null==n["return"]||n["return"]()}finally{if(s)throw i}}return o}}var o=n("06c5");function a(){throw new TypeError("Invalid attempt to destructure non-iterable instance.\nIn order to be iterable, non-array objects must have a [Symbol.iterator]() method.")}function s(t,e){return r(t)||i(t,e)||Object(o["a"])(t,e)||a()}},"387f":function(t,e,n){"use strict";t.exports=function(t,e,n,r,i){return t.config=e,n&&(t.code=n),t.request=r,t.response=i,t}},"38cf":function(t,e,n){var r=n("23e7"),i=n("1148");r({target:"String",proto:!0},{repeat:i})},3934:function(t,e,n){"use strict";var r=n("c532");t.exports=r.isStandardBrowserEnv()?function(){var t,e=/(msie|trident)/i.test(navigator.userAgent),n=document.createElement("a");function i(t){var r=t;return e&&(n.setAttribute("href",r),r=n.href),n.setAttribute("href",r),{href:n.href,protocol:n.protocol?n.protocol.replace(/:$/,""):"",host:n.host,search:n.search?n.search.replace(/^\?/,""):"",hash:n.hash?n.hash.replace(/^#/,""):"",hostname:n.hostname,port:n.port,pathname:"/"===n.pathname.charAt(0)?n.pathname:"/"+n.pathname}}return t=i(window.location.href),function(e){var n=r.isString(e)?i(e):e;return n.protocol===t.protocol&&n.host===t.host}}():function(){return function(){return!0}}()},"3bbe":function(t,e,n){var r=n("861d");t.exports=function(t){if(!r(t)&&null!==t)throw TypeError("Can't set "+String(t)+" as a prototype");return t}},"3ca3":function(t,e,n){"use strict";var r=n("6547").charAt,i=n("69f3"),o=n("7dd0"),a="String Iterator",s=i.set,c=i.getterFor(a);o(String,"String",(function(t){s(this,{type:a,string:String(t),index:0})}),(function(){var t,e=c(this),n=e.string,i=e.index;return i>=n.length?{value:void 0,done:!0}:(t=r(n,i),e.index+=t.length,{value:t,done:!1})}))},"3ea3":function(t,e,n){var r=n("23e7"),i=n("f748"),o=Math.abs,a=Math.pow;r({target:"Math",stat:!0},{cbrt:function(t){return i(t=+t)*a(o(t),1/3)}})},"3f8c":function(t,e){t.exports={}},"408a":function(t,e,n){var r=n("c6b6");t.exports=function(t){if("number"!=typeof t&&"Number"!=r(t))throw TypeError("Incorrect invocation");return+t}},"40dc":function(t,e,n){"use strict";var r=n("5530"),i=(n("c7cd"),n("a9e3"),n("8b0d"),n("3835")),o=(n("0481"),n("5e23"),n("8dd9")),a=n("adda"),s=n("80d2"),c=n("d9bd"),u=o["a"].extend({name:"v-toolbar",props:{absolute:Boolean,bottom:Boolean,collapse:Boolean,dense:Boolean,extended:Boolean,extensionHeight:{default:48,type:[Number,String]},flat:Boolean,floating:Boolean,prominent:Boolean,short:Boolean,src:{type:[String,Object],default:""},tag:{type:String,default:"header"}},data:function(){return{isExtended:!1}},computed:{computedHeight:function(){var t=this.computedContentHeight;if(!this.isExtended)return t;var e=parseInt(this.extensionHeight);return this.isCollapsed?t:t+(isNaN(e)?0:e)},computedContentHeight:function(){return this.height?parseInt(this.height):this.isProminent&&this.dense?96:this.isProminent&&this.short?112:this.isProminent?128:this.dense?48:this.short||this.$vuetify.breakpoint.smAndDown?56:64},classes:function(){return Object(r["a"])(Object(r["a"])({},o["a"].options.computed.classes.call(this)),{},{"v-toolbar":!0,"v-toolbar--absolute":this.absolute,"v-toolbar--bottom":this.bottom,"v-toolbar--collapse":this.collapse,"v-toolbar--collapsed":this.isCollapsed,"v-toolbar--dense":this.dense,"v-toolbar--extended":this.isExtended,"v-toolbar--flat":this.flat,"v-toolbar--floating":this.floating,"v-toolbar--prominent":this.isProminent})},isCollapsed:function(){return this.collapse},isProminent:function(){return this.prominent},styles:function(){return Object(r["a"])(Object(r["a"])({},this.measurableStyles),{},{height:Object(s["d"])(this.computedHeight)})}},created:function(){var t=this,e=[["app",""],["manual-scroll",''],["clipped-left",""],["clipped-right",""],["inverted-scroll",""],["scroll-off-screen",""],["scroll-target",""],["scroll-threshold",""],["card",""]];e.forEach((function(e){var n=Object(i["a"])(e,2),r=n[0],o=n[1];t.$attrs.hasOwnProperty(r)&&Object(c["a"])(r,o,t)}))},methods:{genBackground:function(){var t={height:Object(s["d"])(this.computedHeight),src:this.src},e=this.$scopedSlots.img?this.$scopedSlots.img({props:t}):this.$createElement(a["a"],{props:t});return this.$createElement("div",{staticClass:"v-toolbar__image"},[e])},genContent:function(){return this.$createElement("div",{staticClass:"v-toolbar__content",style:{height:Object(s["d"])(this.computedContentHeight)}},Object(s["i"])(this))},genExtension:function(){return this.$createElement("div",{staticClass:"v-toolbar__extension",style:{height:Object(s["d"])(this.extensionHeight)}},Object(s["i"])(this,"extension"))}},render:function(t){this.isExtended=this.extended||!!this.$scopedSlots.extension;var e=[this.genContent()],n=this.setBackgroundColor(this.color,{class:this.classes,style:this.styles,on:this.$listeners});return this.isExtended&&e.push(this.genExtension()),(this.src||this.$scopedSlots.img)&&e.unshift(this.genBackground()),t(this.tag,n,e)}}),l=n("53ca");function f(t,e){var n=e.modifiers||{},r=n.self,i=void 0!==r&&r,o=e.value,a="object"===Object(l["a"])(o)&&o.options||{passive:!0},s="function"===typeof o||"handleEvent"in o?o:o.handler,c=i?t:e.arg?document.querySelector(e.arg):window;c&&(c.addEventListener("scroll",s,a),t._onScroll={handler:s,options:a,target:i?void 0:c})}function d(t){if(t._onScroll){var e=t._onScroll,n=e.handler,r=e.options,i=e.target,o=void 0===i?t:i;o.removeEventListener("scroll",n,r),delete t._onScroll}}var p={inserted:f,unbind:d},h=p,v=n("fe6c"),m=n("58df");function g(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:[];return Object(m["a"])(Object(v["b"])(["absolute","fixed"])).extend({name:"applicationable",props:{app:Boolean},computed:{applicationProperty:function(){return t}},watch:{app:function(t,e){e?this.removeApplication(!0):this.callUpdate()},applicationProperty:function(t,e){this.$vuetify.application.unregister(this._uid,e)}},activated:function(){this.callUpdate()},created:function(){for(var t=0,n=e.length;t0&&void 0!==arguments[0]&&arguments[0];(t||this.app)&&this.$vuetify.application.unregister(this._uid,this.applicationProperty)},updateApplication:function(){return 0}}})}var b=n("2b0e"),y=b["a"].extend({name:"scrollable",directives:{Scroll:p},props:{scrollTarget:String,scrollThreshold:[String,Number]},data:function(){return{currentScroll:0,currentThreshold:0,isActive:!1,isScrollingUp:!1,previousScroll:0,savedScroll:0,target:null}},computed:{canScroll:function(){return"undefined"!==typeof window},computedScrollThreshold:function(){return this.scrollThreshold?Number(this.scrollThreshold):300}},watch:{isScrollingUp:function(){this.savedScroll=this.savedScroll||this.currentScroll},isActive:function(){this.savedScroll=0}},mounted:function(){this.scrollTarget&&(this.target=document.querySelector(this.scrollTarget),this.target||Object(c["c"])("Unable to locate element with identifier ".concat(this.scrollTarget),this))},methods:{onScroll:function(){var t=this;this.canScroll&&(this.previousScroll=this.currentScroll,this.currentScroll=this.target?this.target.scrollTop:window.pageYOffset,this.isScrollingUp=this.currentScrollt.computedScrollThreshold&&t.thresholdMet()})))},thresholdMet:function(){}}}),x=n("d10f"),w=n("f2e7"),_=Object(m["a"])(u,y,x["a"],w["a"],g("top",["clippedLeft","clippedRight","computedHeight","invertedScroll","isExtended","isProminent","value"]));e["a"]=_.extend({name:"v-app-bar",directives:{Scroll:h},provide:function(){return{VAppBar:this}},props:{clippedLeft:Boolean,clippedRight:Boolean,collapseOnScroll:Boolean,elevateOnScroll:Boolean,fadeImgOnScroll:Boolean,hideOnScroll:Boolean,invertedScroll:Boolean,scrollOffScreen:Boolean,shrinkOnScroll:Boolean,value:{type:Boolean,default:!0}},data:function(){return{isActive:this.value}},computed:{applicationProperty:function(){return this.bottom?"bottom":"top"},canScroll:function(){return y.options.computed.canScroll.call(this)&&(this.invertedScroll||this.elevateOnScroll||this.hideOnScroll||this.collapseOnScroll||this.isBooted||!this.value)},classes:function(){return Object(r["a"])(Object(r["a"])({},u.options.computed.classes.call(this)),{},{"v-toolbar--collapse":this.collapse||this.collapseOnScroll,"v-app-bar":!0,"v-app-bar--clipped":this.clippedLeft||this.clippedRight,"v-app-bar--fade-img-on-scroll":this.fadeImgOnScroll,"v-app-bar--elevate-on-scroll":this.elevateOnScroll,"v-app-bar--fixed":!this.absolute&&(this.app||this.fixed),"v-app-bar--hide-shadow":this.hideShadow,"v-app-bar--is-scrolled":this.currentScroll>0,"v-app-bar--shrink-on-scroll":this.shrinkOnScroll})},scrollRatio:function(){var t=this.computedScrollThreshold;return Math.max((t-this.currentScroll)/t,0)},computedContentHeight:function(){if(!this.shrinkOnScroll)return u.options.computed.computedContentHeight.call(this);var t=this.dense?48:56,e=this.computedOriginalHeight;return t+(e-t)*this.scrollRatio},computedFontSize:function(){if(this.isProminent){var t=1.25,e=1.5;return t+(e-t)*this.scrollRatio}},computedLeft:function(){return!this.app||this.clippedLeft?0:this.$vuetify.application.left},computedMarginTop:function(){return this.app?this.$vuetify.application.bar:0},computedOpacity:function(){if(this.fadeImgOnScroll)return this.scrollRatio},computedOriginalHeight:function(){var t=u.options.computed.computedContentHeight.call(this);return this.isExtended&&(t+=parseInt(this.extensionHeight)),t},computedRight:function(){return!this.app||this.clippedRight?0:this.$vuetify.application.right},computedScrollThreshold:function(){return this.scrollThreshold?Number(this.scrollThreshold):this.computedOriginalHeight-(this.dense?48:56)},computedTransform:function(){if(!this.canScroll||this.elevateOnScroll&&0===this.currentScroll&&this.isActive)return 0;if(this.isActive)return 0;var t=this.scrollOffScreen?this.computedHeight:this.computedContentHeight;return this.bottom?t:-t},hideShadow:function(){return this.elevateOnScroll&&this.isExtended?this.currentScroll0:u.options.computed.isCollapsed.call(this)},isProminent:function(){return u.options.computed.isProminent.call(this)||this.shrinkOnScroll},styles:function(){return Object(r["a"])(Object(r["a"])({},u.options.computed.styles.call(this)),{},{fontSize:Object(s["d"])(this.computedFontSize,"rem"),marginTop:Object(s["d"])(this.computedMarginTop),transform:"translateY(".concat(Object(s["d"])(this.computedTransform),")"),left:Object(s["d"])(this.computedLeft),right:Object(s["d"])(this.computedRight)})}},watch:{canScroll:"onScroll",computedTransform:function(){this.canScroll&&(this.clippedLeft||this.clippedRight)&&this.callUpdate()},invertedScroll:function(t){this.isActive=!t||0!==this.currentScroll}},created:function(){this.invertedScroll&&(this.isActive=!1)},methods:{genBackground:function(){var t=u.options.methods.genBackground.call(this);return t.data=this._b(t.data||{},t.tag,{style:{opacity:this.computedOpacity}}),t},updateApplication:function(){return this.invertedScroll?0:this.computedHeight+this.computedTransform},thresholdMet:function(){this.invertedScroll?this.isActive=this.currentScroll>this.computedScrollThreshold:(this.hideOnScroll&&(this.isActive=this.isScrollingUp||this.currentScrolll)if(s=c[l++],s!=s)return!0}else for(;u>l;l++)if((t||l in c)&&c[l]===n)return t||l||0;return!t&&-1}};t.exports={includes:a(!0),indexOf:a(!1)}},"4de4":function(t,e,n){"use strict";var r=n("23e7"),i=n("b727").filter,o=n("1dde"),a=o("filter");r({target:"Array",proto:!0,forced:!a},{filter:function(t){return i(this,t,arguments.length>1?arguments[1]:void 0)}})},"4df4":function(t,e,n){"use strict";var r=n("0366"),i=n("7b0b"),o=n("9bdd"),a=n("e95a"),s=n("50c4"),c=n("8418"),u=n("35a1");t.exports=function(t){var e,n,l,f,d,p,h=i(t),v="function"==typeof this?this:Array,m=arguments.length,g=m>1?arguments[1]:void 0,b=void 0!==g,y=u(h),x=0;if(b&&(g=r(g,m>2?arguments[2]:void 0,2)),void 0==y||v==Array&&a(y))for(e=s(h.length),n=new v(e);e>x;x++)p=b?g(h[x],x):h[x],c(n,x,p);else for(f=y.call(h),d=f.next,n=new v;!(l=d.call(f)).done;x++)p=b?o(f,g,[l.value,x],!0):l.value,c(n,x,p);return n.length=x,n}},"4ec9":function(t,e,n){"use strict";var r=n("6d61"),i=n("6566");t.exports=r("Map",(function(t){return function(){return t(this,arguments.length?arguments[0]:void 0)}}),i)},"50c4":function(t,e,n){var r=n("a691"),i=Math.min;t.exports=function(t){return t>0?i(r(t),9007199254740991):0}},5135:function(t,e,n){var r=n("7b0b"),i={}.hasOwnProperty;t.exports=function(t,e){return i.call(r(t),e)}},5270:function(t,e,n){"use strict";var r=n("c532"),i=n("c401"),o=n("2e67"),a=n("2444"),s=n("d925"),c=n("e683");function u(t){t.cancelToken&&t.cancelToken.throwIfRequested()}t.exports=function(t){u(t),t.baseURL&&!s(t.url)&&(t.url=c(t.baseURL,t.url)),t.headers=t.headers||{},t.data=i(t.data,t.headers,t.transformRequest),t.headers=r.merge(t.headers.common||{},t.headers[t.method]||{},t.headers||{}),r.forEach(["delete","get","head","post","put","patch","common"],(function(e){delete t.headers[e]}));var e=t.adapter||a.adapter;return e(t).then((function(e){return u(t),e.data=i(e.data,e.headers,t.transformResponse),e}),(function(e){return o(e)||(u(t),e&&e.response&&(e.response.data=i(e.response.data,e.response.headers,t.transformResponse))),Promise.reject(e)}))}},5319:function(t,e,n){"use strict";var r=n("d784"),i=n("825a"),o=n("50c4"),a=n("a691"),s=n("1d80"),c=n("8aa5"),u=n("0cb2"),l=n("14c3"),f=Math.max,d=Math.min,p=function(t){return void 0===t?t:String(t)};r("replace",2,(function(t,e,n,r){var h=r.REGEXP_REPLACE_SUBSTITUTES_UNDEFINED_CAPTURE,v=r.REPLACE_KEEPS_$0,m=h?"$":"$0";return[function(n,r){var i=s(this),o=void 0==n?void 0:n[t];return void 0!==o?o.call(n,i,r):e.call(String(i),n,r)},function(t,r){if(!h&&v||"string"===typeof r&&-1===r.indexOf(m)){var s=n(e,t,this,r);if(s.done)return s.value}var g=i(t),b=String(this),y="function"===typeof r;y||(r=String(r));var x=g.global;if(x){var w=g.unicode;g.lastIndex=0}var _=[];while(1){var S=l(g,b);if(null===S)break;if(_.push(S),!x)break;var O=String(S[0]);""===O&&(g.lastIndex=c(b,o(g.lastIndex),w))}for(var C="",k=0,j=0;j<_.length;j++){S=_[j];for(var L=String(S[0]),E=f(d(a(S.index),b.length),0),A=[],$=1;$=k&&(C+=b.slice(k,E)+M,k=E+L.length)}return C+b.slice(k)}]}))},"53ca":function(t,e,n){"use strict";n.d(e,"a",(function(){return r}));n("a4d3"),n("e01a"),n("d3b7"),n("d28b"),n("3ca3"),n("ddb0");function r(t){return r="function"===typeof Symbol&&"symbol"===typeof Symbol.iterator?function(t){return typeof t}:function(t){return t&&"function"===typeof Symbol&&t.constructor===Symbol&&t!==Symbol.prototype?"symbol":typeof t},r(t)}},5530:function(t,e,n){"use strict";n.d(e,"a",(function(){return o}));n("b64b"),n("a4d3"),n("4de4"),n("e439"),n("159b"),n("dbb4");var r=n("ade3");function i(t,e){var n=Object.keys(t);if(Object.getOwnPropertySymbols){var r=Object.getOwnPropertySymbols(t);e&&(r=r.filter((function(e){return Object.getOwnPropertyDescriptor(t,e).enumerable}))),n.push.apply(n,r)}return n}function o(t){for(var e=1;el){var p,h=u(arguments[l++]),v=f?o(h).concat(f(h)):o(h),m=v.length,g=0;while(m>g)p=v[g++],r&&!d.call(h,p)||(n[p]=h[p])}return n}:l},"62ad":function(t,e,n){"use strict";var r=n("ade3"),i=n("5530"),o=(n("a9e3"),n("b64b"),n("ac1f"),n("5319"),n("4ec9"),n("d3b7"),n("3ca3"),n("ddb0"),n("caad"),n("159b"),n("2ca0"),n("4b85"),n("2b0e")),a=n("d9f7"),s=n("80d2"),c=["sm","md","lg","xl"],u=function(){return c.reduce((function(t,e){return t[e]={type:[Boolean,String,Number],default:!1},t}),{})}(),l=function(){return c.reduce((function(t,e){return t["offset"+Object(s["o"])(e)]={type:[String,Number],default:null},t}),{})}(),f=function(){return c.reduce((function(t,e){return t["order"+Object(s["o"])(e)]={type:[String,Number],default:null},t}),{})}(),d={col:Object.keys(u),offset:Object.keys(l),order:Object.keys(f)};function p(t,e,n){var r=t;if(null!=n&&!1!==n){if(e){var i=e.replace(t,"");r+="-".concat(i)}return"col"!==t||""!==n&&!0!==n?(r+="-".concat(n),r.toLowerCase()):r.toLowerCase()}}var h=new Map;e["a"]=o["a"].extend({name:"v-col",functional:!0,props:Object(i["a"])(Object(i["a"])(Object(i["a"])(Object(i["a"])({cols:{type:[Boolean,String,Number],default:!1}},u),{},{offset:{type:[String,Number],default:null}},l),{},{order:{type:[String,Number],default:null}},f),{},{alignSelf:{type:String,default:null,validator:function(t){return["auto","start","end","center","baseline","stretch"].includes(t)}},tag:{type:String,default:"div"}}),render:function(t,e){var n=e.props,i=e.data,o=e.children,s=(e.parent,"");for(var c in n)s+=String(n[c]);var u=h.get(s);return u||function(){var t,e;for(e in u=[],d)d[e].forEach((function(t){var r=n[t],i=p(e,t,r);i&&u.push(i)}));var i=u.some((function(t){return t.startsWith("col-")}));u.push((t={col:!i||!n.cols},Object(r["a"])(t,"col-".concat(n.cols),n.cols),Object(r["a"])(t,"offset-".concat(n.offset),n.offset),Object(r["a"])(t,"order-".concat(n.order),n.order),Object(r["a"])(t,"align-self-".concat(n.alignSelf),n.alignSelf),t)),h.set(s,u)}(),t(n.tag,Object(a["a"])(i,{class:u}),o)}})},6544:function(t,e){t.exports=function(t,e){var n="function"===typeof t.exports?t.exports.extendOptions:t.options;for(var r in"function"===typeof t.exports&&(n.components=t.exports.options.components),n.components=n.components||{},e)n.components[r]=n.components[r]||e[r]}},6547:function(t,e,n){var r=n("a691"),i=n("1d80"),o=function(t){return function(e,n){var o,a,s=String(i(e)),c=r(n),u=s.length;return c<0||c>=u?t?"":void 0:(o=s.charCodeAt(c),o<55296||o>56319||c+1===u||(a=s.charCodeAt(c+1))<56320||a>57343?t?s.charAt(c):o:t?s.slice(c,c+2):a-56320+(o-55296<<10)+65536)}};t.exports={codeAt:o(!1),charAt:o(!0)}},6566:function(t,e,n){"use strict";var r=n("9bf2").f,i=n("7c73"),o=n("e2cc"),a=n("0366"),s=n("19aa"),c=n("2266"),u=n("7dd0"),l=n("2626"),f=n("83ab"),d=n("f183").fastKey,p=n("69f3"),h=p.set,v=p.getterFor;t.exports={getConstructor:function(t,e,n,u){var l=t((function(t,r){s(t,l,e),h(t,{type:e,index:i(null),first:void 0,last:void 0,size:0}),f||(t.size=0),void 0!=r&&c(r,t[u],{that:t,AS_ENTRIES:n})})),p=v(e),m=function(t,e,n){var r,i,o=p(t),a=g(t,e);return a?a.value=n:(o.last=a={index:i=d(e,!0),key:e,value:n,previous:r=o.last,next:void 0,removed:!1},o.first||(o.first=a),r&&(r.next=a),f?o.size++:t.size++,"F"!==i&&(o.index[i]=a)),t},g=function(t,e){var n,r=p(t),i=d(e);if("F"!==i)return r.index[i];for(n=r.first;n;n=n.next)if(n.key==e)return n};return o(l.prototype,{clear:function(){var t=this,e=p(t),n=e.index,r=e.first;while(r)r.removed=!0,r.previous&&(r.previous=r.previous.next=void 0),delete n[r.index],r=r.next;e.first=e.last=void 0,f?e.size=0:t.size=0},delete:function(t){var e=this,n=p(e),r=g(e,t);if(r){var i=r.next,o=r.previous;delete n.index[r.index],r.removed=!0,o&&(o.next=i),i&&(i.previous=o),n.first==r&&(n.first=i),n.last==r&&(n.last=o),f?n.size--:e.size--}return!!r},forEach:function(t){var e,n=p(this),r=a(t,arguments.length>1?arguments[1]:void 0,3);while(e=e?e.next:n.first){r(e.value,e.key,this);while(e&&e.removed)e=e.previous}},has:function(t){return!!g(this,t)}}),o(l.prototype,n?{get:function(t){var e=g(this,t);return e&&e.value},set:function(t,e){return m(this,0===t?0:t,e)}}:{add:function(t){return m(this,t=0===t?0:t,t)}}),f&&r(l.prototype,"size",{get:function(){return p(this).size}}),l},setStrong:function(t,e,n){var r=e+" Iterator",i=v(e),o=v(r);u(t,e,(function(t,e){h(this,{type:r,target:t,state:i(t),kind:e,last:void 0})}),(function(){var t=o(this),e=t.kind,n=t.last;while(n&&n.removed)n=n.previous;return t.target&&(t.last=n=n?n.next:t.state.first)?"keys"==e?{value:n.key,done:!1}:"values"==e?{value:n.value,done:!1}:{value:[n.key,n.value],done:!1}:(t.target=void 0,{value:void 0,done:!0})}),n?"entries":"values",!n,!0),l(e)}}},"65f0":function(t,e,n){var r=n("861d"),i=n("e8b5"),o=n("b622"),a=o("species");t.exports=function(t,e){var n;return i(t)&&(n=t.constructor,"function"!=typeof n||n!==Array&&!i(n.prototype)?r(n)&&(n=n[a],null===n&&(n=void 0)):n=void 0),new(void 0===n?Array:n)(0===e?0:e)}},"69f3":function(t,e,n){var r,i,o,a=n("7f9a"),s=n("da84"),c=n("861d"),u=n("9112"),l=n("5135"),f=n("c6cd"),d=n("f772"),p=n("d012"),h="Object already initialized",v=s.WeakMap,m=function(t){return o(t)?i(t):r(t,{})},g=function(t){return function(e){var n;if(!c(e)||(n=i(e)).type!==t)throw TypeError("Incompatible receiver, "+t+" required");return n}};if(a||f.state){var b=f.state||(f.state=new v),y=b.get,x=b.has,w=b.set;r=function(t,e){if(x.call(b,t))throw new TypeError(h);return e.facade=t,w.call(b,t,e),e},i=function(t){return y.call(b,t)||{}},o=function(t){return x.call(b,t)}}else{var _=d("state");p[_]=!0,r=function(t,e){if(l(t,_))throw new TypeError(h);return e.facade=t,u(t,_,e),e},i=function(t){return l(t,_)?t[_]:{}},o=function(t){return l(t,_)}}t.exports={set:r,get:i,has:o,enforce:m,getterFor:g}},"6d61":function(t,e,n){"use strict";var r=n("23e7"),i=n("da84"),o=n("94ca"),a=n("6eeb"),s=n("f183"),c=n("2266"),u=n("19aa"),l=n("861d"),f=n("d039"),d=n("1c7e"),p=n("d44e"),h=n("7156");t.exports=function(t,e,n){var v=-1!==t.indexOf("Map"),m=-1!==t.indexOf("Weak"),g=v?"set":"add",b=i[t],y=b&&b.prototype,x=b,w={},_=function(t){var e=y[t];a(y,t,"add"==t?function(t){return e.call(this,0===t?0:t),this}:"delete"==t?function(t){return!(m&&!l(t))&&e.call(this,0===t?0:t)}:"get"==t?function(t){return m&&!l(t)?void 0:e.call(this,0===t?0:t)}:"has"==t?function(t){return!(m&&!l(t))&&e.call(this,0===t?0:t)}:function(t,n){return e.call(this,0===t?0:t,n),this})},S=o(t,"function"!=typeof b||!(m||y.forEach&&!f((function(){(new b).entries().next()}))));if(S)x=n.getConstructor(e,t,v,g),s.REQUIRED=!0;else if(o(t,!0)){var O=new x,C=O[g](m?{}:-0,1)!=O,k=f((function(){O.has(1)})),j=d((function(t){new b(t)})),L=!m&&f((function(){var t=new b,e=5;while(e--)t[g](e,e);return!t.has(-0)}));j||(x=e((function(e,n){u(e,x,t);var r=h(new b,e,x);return void 0!=n&&c(n,r[g],{that:r,AS_ENTRIES:v}),r})),x.prototype=y,y.constructor=x),(k||L)&&(_("delete"),_("has"),v&&_("get")),(L||C)&&_(g),m&&y.clear&&delete y.clear}return w[t]=x,r({global:!0,forced:x!=b},w),p(x,t),m||n.setStrong(x,t,v),x}},"6eeb":function(t,e,n){var r=n("da84"),i=n("9112"),o=n("5135"),a=n("ce4e"),s=n("8925"),c=n("69f3"),u=c.get,l=c.enforce,f=String(String).split("String");(t.exports=function(t,e,n,s){var c,u=!!s&&!!s.unsafe,d=!!s&&!!s.enumerable,p=!!s&&!!s.noTargetGet;"function"==typeof n&&("string"!=typeof e||o(n,"name")||i(n,"name",e),c=l(n),c.source||(c.source=f.join("string"==typeof e?e:""))),t!==r?(u?!p&&t[e]&&(d=!0):delete t[e],d?t[e]=n:i(t,e,n)):d?t[e]=n:a(e,n)})(Function.prototype,"toString",(function(){return"function"==typeof this&&u(this).source||s(this)}))},"6f53":function(t,e,n){var r=n("83ab"),i=n("df75"),o=n("fc6a"),a=n("d1e7").f,s=function(t){return function(e){var n,s=o(e),c=i(s),u=c.length,l=0,f=[];while(u>l)n=c[l++],r&&!a.call(s,n)||f.push(t?[n,s[n]]:s[n]);return f}};t.exports={entries:s(!0),values:s(!1)}},7037:function(t,e,n){function r(e){return"function"===typeof Symbol&&"symbol"===typeof Symbol.iterator?(t.exports=r=function(t){return typeof t},t.exports["default"]=t.exports,t.exports.__esModule=!0):(t.exports=r=function(t){return t&&"function"===typeof Symbol&&t.constructor===Symbol&&t!==Symbol.prototype?"symbol":typeof t},t.exports["default"]=t.exports,t.exports.__esModule=!0),r(e)}n("a4d3"),n("e01a"),n("d3b7"),n("d28b"),n("3ca3"),n("ddb0"),t.exports=r,t.exports["default"]=t.exports,t.exports.__esModule=!0},7156:function(t,e,n){var r=n("861d"),i=n("d2bb");t.exports=function(t,e,n){var o,a;return i&&"function"==typeof(o=e.constructor)&&o!==n&&r(a=o.prototype)&&a!==n.prototype&&i(t,a),t}},7418:function(t,e){e.f=Object.getOwnPropertySymbols},7435:function(t,e,n){},"746f":function(t,e,n){var r=n("428f"),i=n("5135"),o=n("e538"),a=n("9bf2").f;t.exports=function(t){var e=r.Symbol||(r.Symbol={});i(e,t)||a(e,t,{value:o.f(t)})}},7496:function(t,e,n){"use strict";var r=n("5530"),i=(n("df86"),n("7560")),o=n("58df");e["a"]=Object(o["a"])(i["a"]).extend({name:"v-app",props:{dark:{type:Boolean,default:void 0},id:{type:String,default:"app"},light:{type:Boolean,default:void 0}},computed:{isDark:function(){return this.$vuetify.theme.dark}},beforeCreate:function(){if(!this.$vuetify||this.$vuetify===this.$root)throw new Error("Vuetify is not properly initialized, see https://vuetifyjs.com/getting-started/quick-start#bootstrapping-the-vuetify-object")},render:function(t){var e=t("div",{staticClass:"v-application--wrap"},this.$slots.default);return t("div",{staticClass:"v-application",class:Object(r["a"])({"v-application--is-rtl":this.$vuetify.rtl,"v-application--is-ltr":!this.$vuetify.rtl},this.themeClasses),attrs:{"data-app":!0},domProps:{id:this.id}},[e])}})},7560:function(t,e,n){"use strict";n("5530");var r=n("2b0e"),i=r["a"].extend().extend({name:"themeable",provide:function(){return{theme:this.themeableProvide}},inject:{theme:{default:{isDark:!1}}},props:{dark:{type:Boolean,default:null},light:{type:Boolean,default:null}},data:function(){return{themeableProvide:{isDark:!1}}},computed:{appIsDark:function(){return this.$vuetify.theme.dark||!1},isDark:function(){return!0===this.dark||!0!==this.light&&this.theme.isDark},themeClasses:function(){return{"theme--dark":this.isDark,"theme--light":!this.isDark}},rootIsDark:function(){return!0===this.dark||!0!==this.light&&this.appIsDark},rootThemeClasses:function(){return{"theme--dark":this.rootIsDark,"theme--light":!this.rootIsDark}}},watch:{isDark:{handler:function(t,e){t!==e&&(this.themeableProvide.isDark=this.isDark)},immediate:!0}}});e["a"]=i},7839:function(t,e){t.exports=["constructor","hasOwnProperty","isPrototypeOf","propertyIsEnumerable","toLocaleString","toString","valueOf"]},"7a77":function(t,e,n){"use strict";function r(t){this.message=t}r.prototype.toString=function(){return"Cancel"+(this.message?": "+this.message:"")},r.prototype.__CANCEL__=!0,t.exports=r},"7aac":function(t,e,n){"use strict";var r=n("c532");t.exports=r.isStandardBrowserEnv()?function(){return{write:function(t,e,n,i,o,a){var s=[];s.push(t+"="+encodeURIComponent(e)),r.isNumber(n)&&s.push("expires="+new Date(n).toGMTString()),r.isString(i)&&s.push("path="+i),r.isString(o)&&s.push("domain="+o),!0===a&&s.push("secure"),document.cookie=s.join("; ")},read:function(t){var e=document.cookie.match(new RegExp("(^|;\\s*)("+t+")=([^;]*)"));return e?decodeURIComponent(e[3]):null},remove:function(t){this.write(t,"",Date.now()-864e5)}}}():function(){return{write:function(){},read:function(){return null},remove:function(){}}}()},"7b0b":function(t,e,n){var r=n("1d80");t.exports=function(t){return Object(r(t))}},"7bc6":function(t,e,n){"use strict";n.d(e,"d",(function(){return i})),n.d(e,"b",(function(){return o})),n.d(e,"c",(function(){return a})),n.d(e,"a",(function(){return s}));n("5530"),n("3835"),n("ac1f"),n("466d"),n("a15b"),n("d81d"),n("1276"),n("b0c0"),n("5319"),n("498a"),n("d3b7"),n("25f0"),n("38cf"),n("99af"),n("fb6a"),n("2ca0"),n("07ac");var r=n("d9bd");n("80d2"),n("8da5");function i(t){return!!t&&!!t.match(/^(#|var\(--|(rgb|hsl)a?\()/)}function o(t){var e;if("number"===typeof t)e=t;else{if("string"!==typeof t)throw new TypeError("Colors can only be numbers or strings, recieved ".concat(null==t?t:t.constructor.name," instead"));var n="#"===t[0]?t.substring(1):t;3===n.length&&(n=n.split("").map((function(t){return t+t})).join("")),6!==n.length&&Object(r["c"])("'".concat(t,"' is not a valid rgb color")),e=parseInt(n,16)}return e<0?(Object(r["c"])("Colors cannot be negative: '".concat(t,"'")),e=0):(e>16777215||isNaN(e))&&(Object(r["c"])("'".concat(t,"' is not a valid rgb color")),e=16777215),e}function a(t){var e=t.toString(16);return e.length<6&&(e="0".repeat(6-e.length)+e),"#"+e}function s(t){return a(o(t))}},"7c73":function(t,e,n){var r,i=n("825a"),o=n("37e8"),a=n("7839"),s=n("d012"),c=n("1be4"),u=n("cc12"),l=n("f772"),f=">",d="<",p="prototype",h="script",v=l("IE_PROTO"),m=function(){},g=function(t){return d+h+f+t+d+"/"+h+f},b=function(t){t.write(g("")),t.close();var e=t.parentWindow.Object;return t=null,e},y=function(){var t,e=u("iframe"),n="java"+h+":";return e.style.display="none",c.appendChild(e),e.src=String(n),t=e.contentWindow.document,t.open(),t.write(g("document.F=Object")),t.close(),t.F},x=function(){try{r=document.domain&&new ActiveXObject("htmlfile")}catch(e){}x=r?b(r):y();var t=a.length;while(t--)delete x[p][a[t]];return x()};s[v]=!0,t.exports=Object.create||function(t,e){var n;return null!==t?(m[p]=i(t),n=new m,m[p]=null,n[v]=t):n=x(),void 0===e?n:o(n,e)}},"7db0":function(t,e,n){"use strict";var r=n("23e7"),i=n("b727").find,o=n("44d2"),a="find",s=!0;a in[]&&Array(1)[a]((function(){s=!1})),r({target:"Array",proto:!0,forced:s},{find:function(t){return i(this,t,arguments.length>1?arguments[1]:void 0)}}),o(a)},"7dd0":function(t,e,n){"use strict";var r=n("23e7"),i=n("9ed3"),o=n("e163"),a=n("d2bb"),s=n("d44e"),c=n("9112"),u=n("6eeb"),l=n("b622"),f=n("c430"),d=n("3f8c"),p=n("ae93"),h=p.IteratorPrototype,v=p.BUGGY_SAFARI_ITERATORS,m=l("iterator"),g="keys",b="values",y="entries",x=function(){return this};t.exports=function(t,e,n,l,p,w,_){i(n,e,l);var S,O,C,k=function(t){if(t===p&&$)return $;if(!v&&t in E)return E[t];switch(t){case g:return function(){return new n(this,t)};case b:return function(){return new n(this,t)};case y:return function(){return new n(this,t)}}return function(){return new n(this)}},j=e+" Iterator",L=!1,E=t.prototype,A=E[m]||E["@@iterator"]||p&&E[p],$=!v&&A||k(p),T="Array"==e&&E.entries||A;if(T&&(S=o(T.call(new t)),h!==Object.prototype&&S.next&&(f||o(S)===h||(a?a(S,h):"function"!=typeof S[m]&&c(S,m,x)),s(S,j,!0,!0),f&&(d[j]=x))),p==b&&A&&A.name!==b&&(L=!0,$=function(){return A.call(this)}),f&&!_||E[m]===$||c(E,m,$),d[e]=$,p)if(O={values:k(b),keys:w?$:k(g),entries:k(y)},_)for(C in O)(v||L||!(C in E))&&u(E,C,O[C]);else r({target:e,proto:!0,forced:v||L},O);return O}},"7e2b":function(t,e,n){"use strict";var r=n("2b0e");function i(t){return function(e,n){for(var r in n)Object.prototype.hasOwnProperty.call(e,r)||this.$delete(this.$data[t],r);for(var i in e)this.$set(this.$data[t],i,e[i])}}e["a"]=r["a"].extend({data:function(){return{attrs$:{},listeners$:{}}},created:function(){this.$watch("$attrs",i("attrs$"),{immediate:!0}),this.$watch("$listeners",i("listeners$"),{immediate:!0})}})},"7f9a":function(t,e,n){var r=n("da84"),i=n("8925"),o=r.WeakMap;t.exports="function"===typeof o&&/native code/.test(i(o))},"80d2":function(t,e,n){"use strict";n.d(e,"e",(function(){return o})),n.d(e,"g",(function(){return s})),n.d(e,"h",(function(){return c})),n.d(e,"f",(function(){return u})),n.d(e,"d",(function(){return l})),n.d(e,"j",(function(){return d})),n.d(e,"n",(function(){return p})),n.d(e,"k",(function(){return h})),n.d(e,"a",(function(){return m})),n.d(e,"o",(function(){return g})),n.d(e,"p",(function(){return b})),n.d(e,"i",(function(){return y})),n.d(e,"c",(function(){return x})),n.d(e,"m",(function(){return w})),n.d(e,"b",(function(){return _})),n.d(e,"l",(function(){return S}));n("3835");var r=n("53ca"),i=(n("5530"),n("ac1f"),n("5319"),n("498a"),n("99af"),n("b64b"),n("1276"),n("a630"),n("3ca3"),n("a9e3"),n("dca8"),n("2ca0"),n("fb6a"),n("d81d"),n("d3b7"),n("25f0"),n("4de4"),n("b0c0"),n("38cf"),n("b680"),n("cb29"),n("2b0e"));function o(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:"div",n=arguments.length>2?arguments[2]:void 0;return i["a"].extend({name:n||t.replace(/__/g,"-"),functional:!0,render:function(n,r){var i=r.data,o=r.children;return i.staticClass="".concat(t," ").concat(i.staticClass||"").trim(),n(e,i,o)}})}try{if("undefined"!==typeof window){var a=Object.defineProperty({},"passive",{get:function(){!0}});window.addEventListener("testListener",a,a),window.removeEventListener("testListener",a,a)}}catch(O){console.warn(O)}function s(t,e,n){var r=e.length-1;if(r<0)return void 0===t?n:t;for(var i=0;i1&&void 0!==arguments[1]?arguments[1]:"px";return null==t||""===t?void 0:isNaN(+t)?String(t):"".concat(Number(t)).concat(e)}function f(t){return null!==t&&"object"===Object(r["a"])(t)}var d=Object.freeze({enter:13,tab:9,delete:46,esc:27,space:32,up:38,down:40,left:37,right:39,end:35,home:36,del:46,backspace:8,insert:45,pageup:33,pagedown:34,shift:16});function p(t,e){var n=t.$vuetify.icons.component;if(e.startsWith("$")){var r="$vuetify.icons.values.".concat(e.split("$").pop().split(".").pop()),i=c(t,r,e);if("string"!==typeof i)return i;e=i}return null==n?e:{component:n,props:{icon:e}}}function h(t){return Object.keys(t)}var v=/-(\w)/g,m=function(t){return t.replace(v,(function(t,e){return e?e.toUpperCase():""}))};function g(t){return t.charAt(0).toUpperCase()+t.slice(1)}function b(t){return null!=t?Array.isArray(t)?t:[t]:[]}function y(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:"default",n=arguments.length>2?arguments[2]:void 0,r=arguments.length>3&&void 0!==arguments[3]&&arguments[3];return t.$scopedSlots[e]?t.$scopedSlots[e](n instanceof Function?n():n):!t.$slots[e]||n&&!r?void 0:t.$slots[e]}function x(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:0,n=arguments.length>2&&void 0!==arguments[2]?arguments[2]:1;return Math.max(e,Math.min(n,t))}function w(t,e){var n=arguments.length>2&&void 0!==arguments[2]?arguments[2]:"0";return t+n.repeat(Math.max(0,e-t.length))}function _(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:1,n=[],r=0;while(r0&&void 0!==arguments[0]?arguments[0]:{},e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:{};for(var n in e){var r=t[n],i=e[n];f(r)&&f(i)?t[n]=S(r,i):t[n]=i}return t}},"81d5":function(t,e,n){"use strict";var r=n("7b0b"),i=n("23cb"),o=n("50c4");t.exports=function(t){var e=r(this),n=o(e.length),a=arguments.length,s=i(a>1?arguments[1]:void 0,n),c=a>2?arguments[2]:void 0,u=void 0===c?n:i(c,n);while(u>s)e[s++]=t;return e}},"825a":function(t,e,n){var r=n("861d");t.exports=function(t){if(!r(t))throw TypeError(String(t)+" is not an object");return t}},8336:function(t,e,n){"use strict";var r=n("53ca"),i=n("3835"),o=n("5530"),a=(n("c7cd"),n("a9e3"),n("caad"),n("86cc"),n("8dd9")),s=a["a"],c=(n("99af"),n("8d4f"),n("90a2")),u=n("a9ad"),l=n("80d2"),f=u["a"].extend({name:"v-progress-circular",directives:{intersect:c["a"]},props:{button:Boolean,indeterminate:Boolean,rotate:{type:[Number,String],default:0},size:{type:[Number,String],default:32},width:{type:[Number,String],default:4},value:{type:[Number,String],default:0}},data:function(){return{radius:20,isVisible:!0}},computed:{calculatedSize:function(){return Number(this.size)+(this.button?8:0)},circumference:function(){return 2*Math.PI*this.radius},classes:function(){return{"v-progress-circular--visible":this.isVisible,"v-progress-circular--indeterminate":this.indeterminate,"v-progress-circular--button":this.button}},normalizedValue:function(){return this.value<0?0:this.value>100?100:parseFloat(this.value)},strokeDashArray:function(){return Math.round(1e3*this.circumference)/1e3},strokeDashOffset:function(){return(100-this.normalizedValue)/100*this.circumference+"px"},strokeWidth:function(){return Number(this.width)/+this.size*this.viewBoxSize*2},styles:function(){return{height:Object(l["d"])(this.calculatedSize),width:Object(l["d"])(this.calculatedSize)}},svgStyles:function(){return{transform:"rotate(".concat(Number(this.rotate),"deg)")}},viewBoxSize:function(){return this.radius/(1-Number(this.width)/+this.size)}},methods:{genCircle:function(t,e){return this.$createElement("circle",{class:"v-progress-circular__".concat(t),attrs:{fill:"transparent",cx:2*this.viewBoxSize,cy:2*this.viewBoxSize,r:this.radius,"stroke-width":this.strokeWidth,"stroke-dasharray":this.strokeDashArray,"stroke-dashoffset":e}})},genSvg:function(){var t=[this.indeterminate||this.genCircle("underlay",0),this.genCircle("overlay",this.strokeDashOffset)];return this.$createElement("svg",{style:this.svgStyles,attrs:{xmlns:"http://www.w3.org/2000/svg",viewBox:"".concat(this.viewBoxSize," ").concat(this.viewBoxSize," ").concat(2*this.viewBoxSize," ").concat(2*this.viewBoxSize)}},t)},genInfo:function(){return this.$createElement("div",{staticClass:"v-progress-circular__info"},this.$slots.default)},onObserve:function(t,e,n){this.isVisible=n}},render:function(t){return t("div",this.setTextColor(this.color,{staticClass:"v-progress-circular",attrs:{role:"progressbar","aria-valuemin":0,"aria-valuemax":100,"aria-valuenow":this.indeterminate?void 0:this.normalizedValue},class:this.classes,directives:[{name:"intersect",value:this.onObserve}],style:this.styles,on:this.$listeners}),[this.genSvg(),this.genInfo()])}}),d=f,p=n("ade3"),h=n("2b0e"),v=n("d9bd");function m(t,e){return function(){return Object(v["c"])("The ".concat(t," component must be used inside a ").concat(e))}}function g(t,e,n){var r=e&&n?{register:m(e,n),unregister:m(e,n)}:null;return h["a"].extend({name:"registrable-inject",inject:Object(p["a"])({},t,{default:r})})}function b(t,e,n){return g(t,e,n).extend({name:"groupable",props:{activeClass:{type:String,default:function(){if(this[t])return this[t].activeClass}},disabled:Boolean},data:function(){return{isActive:!1}},computed:{groupClasses:function(){return this.activeClass?Object(p["a"])({},this.activeClass,this.isActive):{}}},created:function(){this[t]&&this[t].register(this)},beforeDestroy:function(){this[t]&&this[t].unregister(this)},methods:{toggle:function(){this.$emit("change")}}})}b("itemGroup");var y=n("f2e7"),x=n("c995"),w=n("fe6c"),_=(n("9911"),n("498a"),n("ac1f"),n("5319"),n("a4d3"),n("e01a"),n("d3b7"),n("25f0"),n("b0c0"),n("7435"),Symbol("rippleStop")),S=80;function O(t,e){t.style.transform=e,t.style.webkitTransform=e}function C(t,e){t.style.opacity=e.toString()}function k(t){return"TouchEvent"===t.constructor.name}function j(t){return"KeyboardEvent"===t.constructor.name}var L=function(t,e){var n=arguments.length>2&&void 0!==arguments[2]?arguments[2]:{},r=0,i=0;if(!j(t)){var o=e.getBoundingClientRect(),a=k(t)?t.touches[t.touches.length-1]:t;r=a.clientX-o.left,i=a.clientY-o.top}var s=0,c=.3;e._ripple&&e._ripple.circle?(c=.15,s=e.clientWidth/2,s=n.center?s:s+Math.sqrt(Math.pow(r-s,2)+Math.pow(i-s,2))/4):s=Math.sqrt(Math.pow(e.clientWidth,2)+Math.pow(e.clientHeight,2))/2;var u="".concat((e.clientWidth-2*s)/2,"px"),l="".concat((e.clientHeight-2*s)/2,"px"),f=n.center?u:"".concat(r-s,"px"),d=n.center?l:"".concat(i-s,"px");return{radius:s,scale:c,x:f,y:d,centerX:u,centerY:l}},E={show:function(t,e){var n=arguments.length>2&&void 0!==arguments[2]?arguments[2]:{};if(e._ripple&&e._ripple.enabled){var r=document.createElement("span"),i=document.createElement("span");r.appendChild(i),r.className="v-ripple__container",n.class&&(r.className+=" ".concat(n.class));var o=L(t,e,n),a=o.radius,s=o.scale,c=o.x,u=o.y,l=o.centerX,f=o.centerY,d="".concat(2*a,"px");i.className="v-ripple__animation",i.style.width=d,i.style.height=d,e.appendChild(r);var p=window.getComputedStyle(e);p&&"static"===p.position&&(e.style.position="relative",e.dataset.previousPosition="static"),i.classList.add("v-ripple__animation--enter"),i.classList.add("v-ripple__animation--visible"),O(i,"translate(".concat(c,", ").concat(u,") scale3d(").concat(s,",").concat(s,",").concat(s,")")),C(i,0),i.dataset.activated=String(performance.now()),setTimeout((function(){i.classList.remove("v-ripple__animation--enter"),i.classList.add("v-ripple__animation--in"),O(i,"translate(".concat(l,", ").concat(f,") scale3d(1,1,1)")),C(i,.25)}),0)}},hide:function(t){if(t&&t._ripple&&t._ripple.enabled){var e=t.getElementsByClassName("v-ripple__animation");if(0!==e.length){var n=e[e.length-1];if(!n.dataset.isHiding){n.dataset.isHiding="true";var r=performance.now()-Number(n.dataset.activated),i=Math.max(250-r,0);setTimeout((function(){n.classList.remove("v-ripple__animation--in"),n.classList.add("v-ripple__animation--out"),C(n,0),setTimeout((function(){var e=t.getElementsByClassName("v-ripple__animation");1===e.length&&t.dataset.previousPosition&&(t.style.position=t.dataset.previousPosition,delete t.dataset.previousPosition),n.parentNode&&t.removeChild(n.parentNode)}),300)}),i)}}}}};function A(t){return"undefined"===typeof t||!!t}function $(t){var e={},n=t.currentTarget;if(n&&n._ripple&&!n._ripple.touched&&!t[_]){if(t[_]=!0,k(t))n._ripple.touched=!0,n._ripple.isTouch=!0;else if(n._ripple.isTouch)return;if(e.center=n._ripple.centered||j(t),n._ripple.class&&(e.class=n._ripple.class),k(t)){if(n._ripple.showTimerCommit)return;n._ripple.showTimerCommit=function(){E.show(t,n,e)},n._ripple.showTimer=window.setTimeout((function(){n&&n._ripple&&n._ripple.showTimerCommit&&(n._ripple.showTimerCommit(),n._ripple.showTimerCommit=null)}),S)}else E.show(t,n,e)}}function T(t){var e=t.currentTarget;if(e&&e._ripple){if(window.clearTimeout(e._ripple.showTimer),"touchend"===t.type&&e._ripple.showTimerCommit)return e._ripple.showTimerCommit(),e._ripple.showTimerCommit=null,void(e._ripple.showTimer=setTimeout((function(){T(t)})));window.setTimeout((function(){e._ripple&&(e._ripple.touched=!1)})),E.hide(e)}}function P(t){var e=t.currentTarget;e&&e._ripple&&(e._ripple.showTimerCommit&&(e._ripple.showTimerCommit=null),window.clearTimeout(e._ripple.showTimer))}var M=!1;function I(t){M||t.keyCode!==l["j"].enter&&t.keyCode!==l["j"].space||(M=!0,$(t))}function N(t){M=!1,T(t)}function B(t){!0===M&&(M=!1,T(t))}function R(t,e,n){var r=A(e.value);r||E.hide(t),t._ripple=t._ripple||{},t._ripple.enabled=r;var i=e.value||{};i.center&&(t._ripple.centered=!0),i.class&&(t._ripple.class=e.value.class),i.circle&&(t._ripple.circle=i.circle),r&&!n?(t.addEventListener("touchstart",$,{passive:!0}),t.addEventListener("touchend",T,{passive:!0}),t.addEventListener("touchmove",P,{passive:!0}),t.addEventListener("touchcancel",T),t.addEventListener("mousedown",$),t.addEventListener("mouseup",T),t.addEventListener("mouseleave",T),t.addEventListener("keydown",I),t.addEventListener("keyup",N),t.addEventListener("blur",B),t.addEventListener("dragstart",T,{passive:!0})):!r&&n&&D(t)}function D(t){t.removeEventListener("mousedown",$),t.removeEventListener("touchstart",$),t.removeEventListener("touchend",T),t.removeEventListener("touchmove",P),t.removeEventListener("touchcancel",T),t.removeEventListener("mouseup",T),t.removeEventListener("mouseleave",T),t.removeEventListener("keydown",I),t.removeEventListener("keyup",N),t.removeEventListener("dragstart",T),t.removeEventListener("blur",B)}function F(t,e,n){R(t,e,!1)}function H(t){delete t._ripple,D(t)}function z(t,e){if(e.value!==e.oldValue){var n=A(e.oldValue);R(t,e,n)}}var V={bind:F,unbind:H,update:z},U=V,W=h["a"].extend({name:"routable",directives:{Ripple:U},props:{activeClass:String,append:Boolean,disabled:Boolean,exact:{type:Boolean,default:void 0},exactActiveClass:String,link:Boolean,href:[String,Object],to:[String,Object],nuxt:Boolean,replace:Boolean,ripple:{type:[Boolean,Object],default:null},tag:String,target:String},data:function(){return{isActive:!1,proxyClass:""}},computed:{classes:function(){var t={};return this.to||(this.activeClass&&(t[this.activeClass]=this.isActive),this.proxyClass&&(t[this.proxyClass]=this.isActive)),t},computedRipple:function(){var t;return null!=(t=this.ripple)?t:!this.disabled&&this.isClickable},isClickable:function(){return!this.disabled&&Boolean(this.isLink||this.$listeners.click||this.$listeners["!click"]||this.$attrs.tabindex)},isLink:function(){return this.to||this.href||this.link},styles:function(){return{}}},watch:{$route:"onRouteChange"},methods:{click:function(t){this.$emit("click",t)},generateRouteLink:function(){var t,e,n=this.exact,r=(t={attrs:{tabindex:"tabindex"in this.$attrs?this.$attrs.tabindex:void 0},class:this.classes,style:this.styles,props:{},directives:[{name:"ripple",value:this.computedRipple}]},Object(p["a"])(t,this.to?"nativeOn":"on",Object(o["a"])(Object(o["a"])({},this.$listeners),{},{click:this.click})),Object(p["a"])(t,"ref","link"),t);if("undefined"===typeof this.exact&&(n="/"===this.to||this.to===Object(this.to)&&"/"===this.to.path),this.to){var i=this.activeClass,a=this.exactActiveClass||i;this.proxyClass&&(i="".concat(i," ").concat(this.proxyClass).trim(),a="".concat(a," ").concat(this.proxyClass).trim()),e=this.nuxt?"nuxt-link":"router-link",Object.assign(r.props,{to:this.to,exact:n,activeClass:i,exactActiveClass:a,append:this.append,replace:this.replace})}else e=(this.href?"a":this.tag)||"div","a"===e&&this.href&&(r.attrs.href=this.href);return this.target&&(r.attrs.target=this.target),{tag:e,data:r}},onRouteChange:function(){var t=this;if(this.to&&this.$refs.link&&this.$route){var e="".concat(this.activeClass," ").concat(this.proxyClass||"").trim(),n="_vnode.data.class.".concat(e);this.$nextTick((function(){Object(l["h"])(t.$refs.link,n)&&t.toggle()}))}},toggle:function(){}}}),q=n("af2b"),Z=n("58df"),G=Object(Z["a"])(s,W,w["a"],q["a"],b("btnToggle"),Object(y["b"])("inputValue"));e["a"]=G.extend().extend({name:"v-btn",props:{activeClass:{type:String,default:function(){return this.btnToggle?this.btnToggle.activeClass:""}},block:Boolean,depressed:Boolean,fab:Boolean,icon:Boolean,loading:Boolean,outlined:Boolean,plain:Boolean,retainFocusOnClick:Boolean,rounded:Boolean,tag:{type:String,default:"button"},text:Boolean,tile:Boolean,type:{type:String,default:"button"},value:null},data:function(){return{proxyClass:"v-btn--active"}},computed:{classes:function(){return Object(o["a"])(Object(o["a"])(Object(o["a"])(Object(o["a"])(Object(o["a"])({"v-btn":!0},W.options.computed.classes.call(this)),{},{"v-btn--absolute":this.absolute,"v-btn--block":this.block,"v-btn--bottom":this.bottom,"v-btn--disabled":this.disabled,"v-btn--is-elevated":this.isElevated,"v-btn--fab":this.fab,"v-btn--fixed":this.fixed,"v-btn--has-bg":this.hasBg,"v-btn--icon":this.icon,"v-btn--left":this.left,"v-btn--loading":this.loading,"v-btn--outlined":this.outlined,"v-btn--plain":this.plain,"v-btn--right":this.right,"v-btn--round":this.isRound,"v-btn--rounded":this.rounded,"v-btn--router":this.to,"v-btn--text":this.text,"v-btn--tile":this.tile,"v-btn--top":this.top},this.themeClasses),this.groupClasses),this.elevationClasses),this.sizeableClasses)},computedElevation:function(){if(!this.disabled)return x["a"].options.computed.computedElevation.call(this)},computedRipple:function(){var t,e=!this.icon&&!this.fab||{circle:!0};return!this.disabled&&(null!=(t=this.ripple)?t:e)},hasBg:function(){return!this.text&&!this.plain&&!this.outlined&&!this.icon},isElevated:function(){return Boolean(!this.icon&&!this.text&&!this.outlined&&!this.depressed&&!this.disabled&&!this.plain&&(null==this.elevation||Number(this.elevation)>0))},isRound:function(){return Boolean(this.icon||this.fab)},styles:function(){return Object(o["a"])({},this.measurableStyles)}},created:function(){var t=this,e=[["flat","text"],["outline","outlined"],["round","rounded"]];e.forEach((function(e){var n=Object(i["a"])(e,2),r=n[0],o=n[1];t.$attrs.hasOwnProperty(r)&&Object(v["a"])(r,o,t)}))},methods:{click:function(t){!this.retainFocusOnClick&&!this.fab&&t.detail&&this.$el.blur(),this.$emit("click",t),this.btnToggle&&this.toggle()},genContent:function(){return this.$createElement("span",{staticClass:"v-btn__content"},this.$slots.default)},genLoader:function(){return this.$createElement("span",{class:"v-btn__loader"},this.$slots.loader||[this.$createElement(d,{props:{indeterminate:!0,size:23,width:2}})])}},render:function(t){var e=[this.genContent(),this.loading&&this.genLoader()],n=this.generateRouteLink(),i=n.tag,o=n.data,a=this.hasBg?this.setBackgroundColor:this.setTextColor;return"button"===i&&(o.attrs.type=this.type,o.attrs.disabled=this.disabled),o.attrs.value=["string","number"].includes(Object(r["a"])(this.value))?this.value:JSON.stringify(this.value),t(i,this.disabled?o:a(this.color,o),e)}})},"83ab":function(t,e,n){var r=n("d039");t.exports=!r((function(){return 7!=Object.defineProperty({},1,{get:function(){return 7}})[1]}))},8418:function(t,e,n){"use strict";var r=n("c04e"),i=n("9bf2"),o=n("5c6c");t.exports=function(t,e,n){var a=r(e);a in t?i.f(t,a,o(0,n)):t[a]=n}},"857a":function(t,e,n){var r=n("1d80"),i=/"/g;t.exports=function(t,e,n,o){var a=String(r(t)),s="<"+e;return""!==n&&(s+=" "+n+'="'+String(o).replace(i,""")+'"'),s+">"+a+""}},"861d":function(t,e){t.exports=function(t){return"object"===typeof t?null!==t:"function"===typeof t}},"86cc":function(t,e,n){},8925:function(t,e,n){var r=n("c6cd"),i=Function.toString;"function"!=typeof r.inspectSource&&(r.inspectSource=function(t){return i.call(t)}),t.exports=r.inspectSource},"8a79":function(t,e,n){"use strict";var r=n("23e7"),i=n("06cf").f,o=n("50c4"),a=n("5a34"),s=n("1d80"),c=n("ab13"),u=n("c430"),l="".endsWith,f=Math.min,d=c("endsWith"),p=!u&&!d&&!!function(){var t=i(String.prototype,"endsWith");return t&&!t.writable}();r({target:"String",proto:!0,forced:!p&&!d},{endsWith:function(t){var e=String(s(this));a(t);var n=arguments.length>1?arguments[1]:void 0,r=o(e.length),i=void 0===n?r:f(o(n),r),c=String(t);return l?l.call(e,c,i):e.slice(i-c.length,i)===c}})},"8aa5":function(t,e,n){"use strict";var r=n("6547").charAt;t.exports=function(t,e,n){return e+(n?r(t,e).length:1)}},"8b0d":function(t,e,n){},"8d4f":function(t,e,n){},"8da5":function(t,e,n){"use strict";n.d(e,"a",(function(){return c})),n.d(e,"b",(function(){return u}));var r=n("80d2"),i=[[3.2406,-1.5372,-.4986],[-.9689,1.8758,.0415],[.0557,-.204,1.057]],o=function(t){return t<=.0031308?12.92*t:1.055*Math.pow(t,1/2.4)-.055},a=[[.4124,.3576,.1805],[.2126,.7152,.0722],[.0193,.1192,.9505]],s=function(t){return t<=.04045?t/12.92:Math.pow((t+.055)/1.055,2.4)};function c(t){for(var e=Array(3),n=o,a=i,s=0;s<3;++s)e[s]=Math.round(255*Object(r["c"])(n(a[s][0]*t[0]+a[s][1]*t[1]+a[s][2]*t[2])));return(e[0]<<16)+(e[1]<<8)+(e[2]<<0)}function u(t){for(var e=[0,0,0],n=s,r=a,i=n((t>>16&255)/255),o=n((t>>8&255)/255),c=n((t>>0&255)/255),u=0;u<3;++u)e[u]=r[u][0]*i+r[u][1]*o+r[u][2]*c;return e}},"8dd9":function(t,e,n){"use strict";var r=n("5530"),i=(n("25a8"),n("7e2b")),o=n("a9ad"),a=n("c995"),s=n("24b2"),c=n("ade3"),u=n("b85c"),l=(n("ac1f"),n("1276"),n("a15b"),n("2b0e")),f=l["a"].extend({name:"roundable",props:{rounded:[Boolean,String],tile:Boolean},computed:{roundedClasses:function(){var t=[],e="string"===typeof this.rounded?String(this.rounded):!0===this.rounded;if(this.tile)t.push("rounded-0");else if("string"===typeof e){var n,r=e.split(" "),i=Object(u["a"])(r);try{for(i.s();!(n=i.n()).done;){var o=n.value;t.push("rounded-".concat(o))}}catch(a){i.e(a)}finally{i.f()}}else e&&t.push("rounded");return t.length>0?Object(c["a"])({},t.join(" "),!0):{}}}}),d=n("7560"),p=n("58df");e["a"]=Object(p["a"])(i["a"],o["a"],a["a"],s["a"],f,d["a"]).extend({name:"v-sheet",props:{outlined:Boolean,shaped:Boolean,tag:{type:String,default:"div"}},computed:{classes:function(){return Object(r["a"])(Object(r["a"])(Object(r["a"])({"v-sheet":!0,"v-sheet--outlined":this.outlined,"v-sheet--shaped":this.shaped},this.themeClasses),this.elevationClasses),this.roundedClasses)},styles:function(){return this.measurableStyles}},render:function(t){var e={class:this.classes,style:this.styles,on:this.listeners$};return t(this.tag,this.setBackgroundColor(this.color,e),this.$slots.default)}})},"8df4":function(t,e,n){"use strict";var r=n("7a77");function i(t){if("function"!==typeof t)throw new TypeError("executor must be a function.");var e;this.promise=new Promise((function(t){e=t}));var n=this;t((function(t){n.reason||(n.reason=new r(t),e(n.reason))}))}i.prototype.throwIfRequested=function(){if(this.reason)throw this.reason},i.source=function(){var t,e=new i((function(e){t=e}));return{token:e,cancel:t}},t.exports=i},"8efc":function(t,e,n){},"90a2":function(t,e,n){"use strict";var r=n("53ca");n("7db0");function i(t,e){var n=e.modifiers||{},i=e.value,a="object"===Object(r["a"])(i)?i:{handler:i,options:{}},s=a.handler,c=a.options,u=new IntersectionObserver((function(){var e=arguments.length>0&&void 0!==arguments[0]?arguments[0]:[],r=arguments.length>1?arguments[1]:void 0;if(t._observe){if(s&&(!n.quiet||t._observe.init)){var i=Boolean(e.find((function(t){return t.isIntersecting})));s(e,r,i)}t._observe.init&&n.once?o(t):t._observe.init=!0}}),c);t._observe={init:!1,observer:u},u.observe(t)}function o(t){t._observe&&(t._observe.observer.unobserve(t),delete t._observe)}var a={inserted:i,unbind:o};e["a"]=a},"90e3":function(t,e){var n=0,r=Math.random();t.exports=function(t){return"Symbol("+String(void 0===t?"":t)+")_"+(++n+r).toString(36)}},9112:function(t,e,n){var r=n("83ab"),i=n("9bf2"),o=n("5c6c");t.exports=r?function(t,e,n){return i.f(t,e,o(1,n))}:function(t,e,n){return t[e]=n,t}},9263:function(t,e,n){"use strict";var r=n("ad6d"),i=n("9f7f"),o=n("5692"),a=RegExp.prototype.exec,s=o("native-string-replace",String.prototype.replace),c=a,u=function(){var t=/a/,e=/b*/g;return a.call(t,"a"),a.call(e,"a"),0!==t.lastIndex||0!==e.lastIndex}(),l=i.UNSUPPORTED_Y||i.BROKEN_CARET,f=void 0!==/()??/.exec("")[1],d=u||f||l;d&&(c=function(t){var e,n,i,o,c=this,d=l&&c.sticky,p=r.call(c),h=c.source,v=0,m=t;return d&&(p=p.replace("y",""),-1===p.indexOf("g")&&(p+="g"),m=String(t).slice(c.lastIndex),c.lastIndex>0&&(!c.multiline||c.multiline&&"\n"!==t[c.lastIndex-1])&&(h="(?: "+h+")",m=" "+m,v++),n=new RegExp("^(?:"+h+")",p)),f&&(n=new RegExp("^"+h+"$(?!\\s)",p)),u&&(e=c.lastIndex),i=a.call(d?n:c,m),d?i?(i.input=i.input.slice(v),i[0]=i[0].slice(v),i.index=c.lastIndex,c.lastIndex+=i[0].length):c.lastIndex=0:u&&i&&(c.lastIndex=c.global?i.index+i[0].length:e),f&&i&&i.length>1&&s.call(i[0],n,(function(){for(o=1;o=51||!i((function(){var t=[];return t[h]=!1,t.concat()[0]!==t})),b=f("concat"),y=function(t){if(!a(t))return!1;var e=t[h];return void 0!==e?!!e:o(t)},x=!g||!b;r({target:"Array",proto:!0,forced:x},{concat:function(t){var e,n,r,i,o,a=s(this),f=l(a,0),d=0;for(e=-1,r=arguments.length;ev)throw TypeError(m);for(n=0;n=v)throw TypeError(m);u(f,d++,o)}return f.length=d,f}})},"9bdd":function(t,e,n){var r=n("825a"),i=n("2a62");t.exports=function(t,e,n,o){try{return o?e(r(n)[0],n[1]):e(n)}catch(a){throw i(t),a}}},"9bf2":function(t,e,n){var r=n("83ab"),i=n("0cfb"),o=n("825a"),a=n("c04e"),s=Object.defineProperty;e.f=r?s:function(t,e,n){if(o(t),e=a(e,!0),o(n),i)try{return s(t,e,n)}catch(r){}if("get"in n||"set"in n)throw TypeError("Accessors not supported");return"value"in n&&(t[e]=n.value),t}},"9ed3":function(t,e,n){"use strict";var r=n("ae93").IteratorPrototype,i=n("7c73"),o=n("5c6c"),a=n("d44e"),s=n("3f8c"),c=function(){return this};t.exports=function(t,e,n){var u=e+" Iterator";return t.prototype=i(r,{next:o(1,n)}),a(t,u,!1,!0),s[u]=c,t}},"9f7f":function(t,e,n){"use strict";var r=n("d039");function i(t,e){return RegExp(t,e)}e.UNSUPPORTED_Y=r((function(){var t=i("a","y");return t.lastIndex=2,null!=t.exec("abcd")})),e.BROKEN_CARET=r((function(){var t=i("^r","gy");return t.lastIndex=2,null!=t.exec("str")}))},a15b:function(t,e,n){"use strict";var r=n("23e7"),i=n("44ad"),o=n("fc6a"),a=n("a640"),s=[].join,c=i!=Object,u=a("join",",");r({target:"Array",proto:!0,forced:c||!u},{join:function(t){return s.call(o(this),void 0===t?",":t)}})},a2bf:function(t,e,n){"use strict";var r=n("e8b5"),i=n("50c4"),o=n("0366"),a=function(t,e,n,s,c,u,l,f){var d,p=c,h=0,v=!!l&&o(l,f,3);while(h0&&r(d))p=a(t,e,d,i(d.length),p,u-1)-1;else{if(p>=9007199254740991)throw TypeError("Exceed the acceptable array length");t[p]=d}p++}h++}return p};t.exports=a},a4b4:function(t,e,n){var r=n("342f");t.exports=/web0s(?!.*chrome)/i.test(r)},a4d3:function(t,e,n){"use strict";var r=n("23e7"),i=n("da84"),o=n("d066"),a=n("c430"),s=n("83ab"),c=n("4930"),u=n("fdbf"),l=n("d039"),f=n("5135"),d=n("e8b5"),p=n("861d"),h=n("825a"),v=n("7b0b"),m=n("fc6a"),g=n("c04e"),b=n("5c6c"),y=n("7c73"),x=n("df75"),w=n("241c"),_=n("057f"),S=n("7418"),O=n("06cf"),C=n("9bf2"),k=n("d1e7"),j=n("9112"),L=n("6eeb"),E=n("5692"),A=n("f772"),$=n("d012"),T=n("90e3"),P=n("b622"),M=n("e538"),I=n("746f"),N=n("d44e"),B=n("69f3"),R=n("b727").forEach,D=A("hidden"),F="Symbol",H="prototype",z=P("toPrimitive"),V=B.set,U=B.getterFor(F),W=Object[H],q=i.Symbol,Z=o("JSON","stringify"),G=O.f,K=C.f,X=_.f,Y=k.f,Q=E("symbols"),J=E("op-symbols"),tt=E("string-to-symbol-registry"),et=E("symbol-to-string-registry"),nt=E("wks"),rt=i.QObject,it=!rt||!rt[H]||!rt[H].findChild,ot=s&&l((function(){return 7!=y(K({},"a",{get:function(){return K(this,"a",{value:7}).a}})).a}))?function(t,e,n){var r=G(W,e);r&&delete W[e],K(t,e,n),r&&t!==W&&K(W,e,r)}:K,at=function(t,e){var n=Q[t]=y(q[H]);return V(n,{type:F,tag:t,description:e}),s||(n.description=e),n},st=u?function(t){return"symbol"==typeof t}:function(t){return Object(t)instanceof q},ct=function(t,e,n){t===W&&ct(J,e,n),h(t);var r=g(e,!0);return h(n),f(Q,r)?(n.enumerable?(f(t,D)&&t[D][r]&&(t[D][r]=!1),n=y(n,{enumerable:b(0,!1)})):(f(t,D)||K(t,D,b(1,{})),t[D][r]=!0),ot(t,r,n)):K(t,r,n)},ut=function(t,e){h(t);var n=m(e),r=x(n).concat(ht(n));return R(r,(function(e){s&&!ft.call(n,e)||ct(t,e,n[e])})),t},lt=function(t,e){return void 0===e?y(t):ut(y(t),e)},ft=function(t){var e=g(t,!0),n=Y.call(this,e);return!(this===W&&f(Q,e)&&!f(J,e))&&(!(n||!f(this,e)||!f(Q,e)||f(this,D)&&this[D][e])||n)},dt=function(t,e){var n=m(t),r=g(e,!0);if(n!==W||!f(Q,r)||f(J,r)){var i=G(n,r);return!i||!f(Q,r)||f(n,D)&&n[D][r]||(i.enumerable=!0),i}},pt=function(t){var e=X(m(t)),n=[];return R(e,(function(t){f(Q,t)||f($,t)||n.push(t)})),n},ht=function(t){var e=t===W,n=X(e?J:m(t)),r=[];return R(n,(function(t){!f(Q,t)||e&&!f(W,t)||r.push(Q[t])})),r};if(c||(q=function(){if(this instanceof q)throw TypeError("Symbol is not a constructor");var t=arguments.length&&void 0!==arguments[0]?String(arguments[0]):void 0,e=T(t),n=function(t){this===W&&n.call(J,t),f(this,D)&&f(this[D],e)&&(this[D][e]=!1),ot(this,e,b(1,t))};return s&&it&&ot(W,e,{configurable:!0,set:n}),at(e,t)},L(q[H],"toString",(function(){return U(this).tag})),L(q,"withoutSetter",(function(t){return at(T(t),t)})),k.f=ft,C.f=ct,O.f=dt,w.f=_.f=pt,S.f=ht,M.f=function(t){return at(P(t),t)},s&&(K(q[H],"description",{configurable:!0,get:function(){return U(this).description}}),a||L(W,"propertyIsEnumerable",ft,{unsafe:!0}))),r({global:!0,wrap:!0,forced:!c,sham:!c},{Symbol:q}),R(x(nt),(function(t){I(t)})),r({target:F,stat:!0,forced:!c},{for:function(t){var e=String(t);if(f(tt,e))return tt[e];var n=q(e);return tt[e]=n,et[n]=e,n},keyFor:function(t){if(!st(t))throw TypeError(t+" is not a symbol");if(f(et,t))return et[t]},useSetter:function(){it=!0},useSimple:function(){it=!1}}),r({target:"Object",stat:!0,forced:!c,sham:!s},{create:lt,defineProperty:ct,defineProperties:ut,getOwnPropertyDescriptor:dt}),r({target:"Object",stat:!0,forced:!c},{getOwnPropertyNames:pt,getOwnPropertySymbols:ht}),r({target:"Object",stat:!0,forced:l((function(){S.f(1)}))},{getOwnPropertySymbols:function(t){return S.f(v(t))}}),Z){var vt=!c||l((function(){var t=q();return"[null]"!=Z([t])||"{}"!=Z({a:t})||"{}"!=Z(Object(t))}));r({target:"JSON",stat:!0,forced:vt},{stringify:function(t,e,n){var r,i=[t],o=1;while(arguments.length>o)i.push(arguments[o++]);if(r=e,(p(e)||void 0!==t)&&!st(t))return d(e)||(e=function(t,e){if("function"==typeof r&&(e=r.call(this,t,e)),!st(e))return e}),i[1]=e,Z.apply(null,i)}})}q[H][z]||j(q[H],z,q[H].valueOf),N(q,F),$[D]=!0},a523:function(t,e,n){"use strict";n("4de4"),n("b64b"),n("2ca0"),n("99af"),n("20f6"),n("4b85"),n("498a"),n("a15b");var r=n("2b0e");function i(t){return r["a"].extend({name:"v-".concat(t),functional:!0,props:{id:String,tag:{type:String,default:"div"}},render:function(e,n){var r=n.props,i=n.data,o=n.children;i.staticClass="".concat(t," ").concat(i.staticClass||"").trim();var a=i.attrs;if(a){i.attrs={};var s=Object.keys(a).filter((function(t){if("slot"===t)return!1;var e=a[t];return t.startsWith("data-")?(i.attrs[t]=e,!1):e||"string"===typeof e}));s.length&&(i.staticClass+=" ".concat(s.join(" ")))}return r.id&&(i.domProps=i.domProps||{},i.domProps.id=r.id),e(r.tag,i,o)}})}var o=n("d9f7");e["a"]=i("container").extend({name:"v-container",functional:!0,props:{id:String,tag:{type:String,default:"div"},fluid:{type:Boolean,default:!1}},render:function(t,e){var n,r=e.props,i=e.data,a=e.children,s=i.attrs;return s&&(i.attrs={},n=Object.keys(s).filter((function(t){if("slot"===t)return!1;var e=s[t];return t.startsWith("data-")?(i.attrs[t]=e,!1):e||"string"===typeof e}))),r.id&&(i.domProps=i.domProps||{},i.domProps.id=r.id),t(r.tag,Object(o["a"])(i,{staticClass:"container",class:Array({"container--fluid":r.fluid}).concat(n||[])}),a)}})},a630:function(t,e,n){var r=n("23e7"),i=n("4df4"),o=n("1c7e"),a=!o((function(t){Array.from(t)}));r({target:"Array",stat:!0,forced:a},{from:i})},a640:function(t,e,n){"use strict";var r=n("d039");t.exports=function(t,e){var n=[][t];return!!n&&r((function(){n.call(null,e||function(){throw 1},1)}))}},a691:function(t,e){var n=Math.ceil,r=Math.floor;t.exports=function(t){return isNaN(t=+t)?0:(t>0?r:n)(t)}},a79d:function(t,e,n){"use strict";var r=n("23e7"),i=n("c430"),o=n("fea9"),a=n("d039"),s=n("d066"),c=n("4840"),u=n("cdf9"),l=n("6eeb"),f=!!o&&a((function(){o.prototype["finally"].call({then:function(){}},(function(){}))}));if(r({target:"Promise",proto:!0,real:!0,forced:f},{finally:function(t){var e=c(this,s("Promise")),n="function"==typeof t;return this.then(n?function(n){return u(e,t()).then((function(){return n}))}:t,n?function(n){return u(e,t()).then((function(){throw n}))}:t)}}),!i&&"function"==typeof o){var d=s("Promise").prototype["finally"];o.prototype["finally"]!==d&&l(o.prototype,"finally",d,{unsafe:!0})}},a9ad:function(t,e,n){"use strict";var r=n("3835"),i=n("ade3"),o=n("5530"),a=(n("ac1f"),n("1276"),n("498a"),n("d3b7"),n("25f0"),n("2b0e")),s=n("d9bd"),c=n("7bc6");e["a"]=a["a"].extend({name:"colorable",props:{color:String},methods:{setBackgroundColor:function(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:{};return"string"===typeof e.style?(Object(s["b"])("style must be an object",this),e):"string"===typeof e.class?(Object(s["b"])("class must be an object",this),e):(Object(c["d"])(t)?e.style=Object(o["a"])(Object(o["a"])({},e.style),{},{"background-color":"".concat(t),"border-color":"".concat(t)}):t&&(e.class=Object(o["a"])(Object(o["a"])({},e.class),{},Object(i["a"])({},t,!0))),e)},setTextColor:function(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:{};if("string"===typeof e.style)return Object(s["b"])("style must be an object",this),e;if("string"===typeof e.class)return Object(s["b"])("class must be an object",this),e;if(Object(c["d"])(t))e.style=Object(o["a"])(Object(o["a"])({},e.style),{},{color:"".concat(t),"caret-color":"".concat(t)});else if(t){var n=t.toString().trim().split(" ",2),a=Object(r["a"])(n,2),u=a[0],l=a[1];e.class=Object(o["a"])(Object(o["a"])({},e.class),{},Object(i["a"])({},u+"--text",!0)),l&&(e.class["text--"+l]=!0)}return e}}})},a9e3:function(t,e,n){"use strict";var r=n("83ab"),i=n("da84"),o=n("94ca"),a=n("6eeb"),s=n("5135"),c=n("c6b6"),u=n("7156"),l=n("c04e"),f=n("d039"),d=n("7c73"),p=n("241c").f,h=n("06cf").f,v=n("9bf2").f,m=n("58a8").trim,g="Number",b=i[g],y=b.prototype,x=c(d(y))==g,w=function(t){var e,n,r,i,o,a,s,c,u=l(t,!1);if("string"==typeof u&&u.length>2)if(u=m(u),e=u.charCodeAt(0),43===e||45===e){if(n=u.charCodeAt(2),88===n||120===n)return NaN}else if(48===e){switch(u.charCodeAt(1)){case 66:case 98:r=2,i=49;break;case 79:case 111:r=8,i=55;break;default:return+u}for(o=u.slice(2),a=o.length,s=0;si)return NaN;return parseInt(o,r)}return+u};if(o(g,!b(" 0o1")||!b("0b1")||b("+0x1"))){for(var _,S=function(t){var e=arguments.length<1?0:t,n=this;return n instanceof S&&(x?f((function(){y.valueOf.call(n)})):c(n)!=g)?u(new b(w(e)),n,S):w(e)},O=r?p(b):"MAX_VALUE,MIN_VALUE,NaN,NEGATIVE_INFINITY,POSITIVE_INFINITY,EPSILON,isFinite,isInteger,isNaN,isSafeInteger,MAX_SAFE_INTEGER,MIN_SAFE_INTEGER,parseFloat,parseInt,isInteger,fromString,range".split(","),C=0;O.length>C;C++)s(b,_=O[C])&&!s(S,_)&&v(S,_,h(b,_));S.prototype=y,y.constructor=S,a(i,g,S)}},ab13:function(t,e,n){var r=n("b622"),i=r("match");t.exports=function(t){var e=/./;try{"/./"[t](e)}catch(n){try{return e[i]=!1,"/./"[t](e)}catch(r){}}return!1}},ac1f:function(t,e,n){"use strict";var r=n("23e7"),i=n("9263");r({target:"RegExp",proto:!0,forced:/./.exec!==i},{exec:i})},ad6d:function(t,e,n){"use strict";var r=n("825a");t.exports=function(){var t=r(this),e="";return t.global&&(e+="g"),t.ignoreCase&&(e+="i"),t.multiline&&(e+="m"),t.dotAll&&(e+="s"),t.unicode&&(e+="u"),t.sticky&&(e+="y"),e}},adda:function(t,e,n){"use strict";var r=n("53ca"),i=(n("a9e3"),n("a15b"),n("8a79"),n("2ca0"),n("8efc"),n("90a2")),o=(n("36a7"),n("24b2")),a=n("58df"),s=Object(a["a"])(o["a"]).extend({name:"v-responsive",props:{aspectRatio:[String,Number],contentClass:String},computed:{computedAspectRatio:function(){return Number(this.aspectRatio)},aspectStyle:function(){return this.computedAspectRatio?{paddingBottom:1/this.computedAspectRatio*100+"%"}:void 0},__cachedSizer:function(){return this.aspectStyle?this.$createElement("div",{style:this.aspectStyle,staticClass:"v-responsive__sizer"}):[]}},methods:{genContent:function(){return this.$createElement("div",{staticClass:"v-responsive__content",class:this.contentClass},this.$slots.default)}},render:function(t){return t("div",{staticClass:"v-responsive",style:this.measurableStyles,on:this.$listeners},[this.__cachedSizer,this.genContent()])}}),c=s,u=n("7560"),l=n("d9f7"),f=n("d9bd"),d="undefined"!==typeof window&&"IntersectionObserver"in window;e["a"]=Object(a["a"])(c,u["a"]).extend({name:"v-img",directives:{intersect:i["a"]},props:{alt:String,contain:Boolean,eager:Boolean,gradient:String,lazySrc:String,options:{type:Object,default:function(){return{root:void 0,rootMargin:void 0,threshold:void 0}}},position:{type:String,default:"center center"},sizes:String,src:{type:[String,Object],default:""},srcset:String,transition:{type:[Boolean,String],default:"fade-transition"}},data:function(){return{currentSrc:"",image:null,isLoading:!0,calculatedAspectRatio:void 0,naturalWidth:void 0,hasError:!1}},computed:{computedAspectRatio:function(){return Number(this.normalisedSrc.aspect||this.calculatedAspectRatio)},normalisedSrc:function(){return this.src&&"object"===Object(r["a"])(this.src)?{src:this.src.src,srcset:this.srcset||this.src.srcset,lazySrc:this.lazySrc||this.src.lazySrc,aspect:Number(this.aspectRatio||this.src.aspect)}:{src:this.src,srcset:this.srcset,lazySrc:this.lazySrc,aspect:Number(this.aspectRatio||0)}},__cachedImage:function(){if(!(this.normalisedSrc.src||this.normalisedSrc.lazySrc||this.gradient))return[];var t=[],e=this.isLoading?this.normalisedSrc.lazySrc:this.currentSrc;this.gradient&&t.push("linear-gradient(".concat(this.gradient,")")),e&&t.push('url("'.concat(e,'")'));var n=this.$createElement("div",{staticClass:"v-image__image",class:{"v-image__image--preload":this.isLoading,"v-image__image--contain":this.contain,"v-image__image--cover":!this.contain},style:{backgroundImage:t.join(", "),backgroundPosition:this.position},key:+this.isLoading});return this.transition?this.$createElement("transition",{attrs:{name:this.transition,mode:"in-out"}},[n]):n}},watch:{src:function(){this.isLoading?this.loadImage():this.init(void 0,void 0,!0)},"$vuetify.breakpoint.width":"getSrc"},mounted:function(){this.init()},methods:{init:function(t,e,n){if(!d||n||this.eager){if(this.normalisedSrc.lazySrc){var r=new Image;r.src=this.normalisedSrc.lazySrc,this.pollForSize(r,null)}this.normalisedSrc.src&&this.loadImage()}},onLoad:function(){this.getSrc(),this.isLoading=!1,this.$emit("load",this.src),this.image&&(this.normalisedSrc.src.endsWith(".svg")||this.normalisedSrc.src.startsWith("data:image/svg+xml"))&&(this.image.naturalHeight&&this.image.naturalWidth?(this.naturalWidth=this.image.naturalWidth,this.calculatedAspectRatio=this.image.naturalWidth/this.image.naturalHeight):this.calculatedAspectRatio=1)},onError:function(){this.hasError=!0,this.$emit("error",this.src)},getSrc:function(){this.image&&(this.currentSrc=this.image.currentSrc||this.image.src)},loadImage:function(){var t=this,e=new Image;this.image=e,e.onload=function(){e.decode?e.decode().catch((function(e){Object(f["c"])("Failed to decode image, trying to render anyway\n\n"+"src: ".concat(t.normalisedSrc.src)+(e.message?"\nOriginal error: ".concat(e.message):""),t)})).then(t.onLoad):t.onLoad()},e.onerror=this.onError,this.hasError=!1,this.sizes&&(e.sizes=this.sizes),this.normalisedSrc.srcset&&(e.srcset=this.normalisedSrc.srcset),e.src=this.normalisedSrc.src,this.$emit("loadstart",this.normalisedSrc.src),this.aspectRatio||this.pollForSize(e),this.getSrc()},pollForSize:function(t){var e=this,n=arguments.length>1&&void 0!==arguments[1]?arguments[1]:100,r=function r(){var i=t.naturalHeight,o=t.naturalWidth;i||o?(e.naturalWidth=o,e.calculatedAspectRatio=o/i):t.complete||!e.isLoading||e.hasError||null==n||setTimeout(r,n)};r()},genContent:function(){var t=c.options.methods.genContent.call(this);return this.naturalWidth&&this._b(t.data,"div",{style:{width:"".concat(this.naturalWidth,"px")}}),t},__genPlaceholder:function(){if(this.$slots.placeholder){var t=this.isLoading?[this.$createElement("div",{staticClass:"v-image__placeholder"},this.$slots.placeholder)]:[];return this.transition?this.$createElement("transition",{props:{appear:!0,name:this.transition}},t):t[0]}}},render:function(t){var e=c.options.render.call(this,t),n=Object(l["a"])(e.data,{staticClass:"v-image",attrs:{"aria-label":this.alt,role:this.alt?"img":void 0},class:this.themeClasses,directives:d?[{name:"intersect",modifiers:{once:!0},value:{handler:this.init,options:this.options}}]:void 0});return e.children=[this.__cachedSizer,this.__cachedImage,this.__genPlaceholder(),this.genContent()],t(e.tag,n,e.children)}})},ade3:function(t,e,n){"use strict";function r(t,e,n){return e in t?Object.defineProperty(t,e,{value:n,enumerable:!0,configurable:!0,writable:!0}):t[e]=n,t}n.d(e,"a",(function(){return r}))},ae93:function(t,e,n){"use strict";var r,i,o,a=n("d039"),s=n("e163"),c=n("9112"),u=n("5135"),l=n("b622"),f=n("c430"),d=l("iterator"),p=!1,h=function(){return this};[].keys&&(o=[].keys(),"next"in o?(i=s(s(o)),i!==Object.prototype&&(r=i)):p=!0);var v=void 0==r||a((function(){var t={};return r[d].call(t)!==t}));v&&(r={}),f&&!v||u(r,d)||c(r,d,h),t.exports={IteratorPrototype:r,BUGGY_SAFARI_ITERATORS:p}},af03:function(t,e,n){var r=n("d039");t.exports=function(t){return r((function(){var e=""[t]('"');return e!==e.toLowerCase()||e.split('"').length>3}))}},af2b:function(t,e,n){"use strict";n("c96a");var r=n("2b0e");e["a"]=r["a"].extend({name:"sizeable",props:{large:Boolean,small:Boolean,xLarge:Boolean,xSmall:Boolean},computed:{medium:function(){return Boolean(!this.xSmall&&!this.small&&!this.large&&!this.xLarge)},sizeableClasses:function(){return{"v-size--x-small":this.xSmall,"v-size--small":this.small,"v-size--default":this.medium,"v-size--large":this.large,"v-size--x-large":this.xLarge}}}})},b041:function(t,e,n){"use strict";var r=n("00ee"),i=n("f5df");t.exports=r?{}.toString:function(){return"[object "+i(this)+"]"}},b0c0:function(t,e,n){var r=n("83ab"),i=n("9bf2").f,o=Function.prototype,a=o.toString,s=/^\s*function ([^ (]*)/,c="name";r&&!(c in o)&&i(o,c,{configurable:!0,get:function(){try{return a.call(this).match(s)[1]}catch(t){return""}}})},b50d:function(t,e,n){"use strict";var r=n("c532"),i=n("467f"),o=n("30b5"),a=n("c345"),s=n("3934"),c=n("2d83");t.exports=function(t){return new Promise((function(e,u){var l=t.data,f=t.headers;r.isFormData(l)&&delete f["Content-Type"];var d=new XMLHttpRequest;if(t.auth){var p=t.auth.username||"",h=t.auth.password||"";f.Authorization="Basic "+btoa(p+":"+h)}if(d.open(t.method.toUpperCase(),o(t.url,t.params,t.paramsSerializer),!0),d.timeout=t.timeout,d.onreadystatechange=function(){if(d&&4===d.readyState&&(0!==d.status||d.responseURL&&0===d.responseURL.indexOf("file:"))){var n="getAllResponseHeaders"in d?a(d.getAllResponseHeaders()):null,r=t.responseType&&"text"!==t.responseType?d.response:d.responseText,o={data:r,status:d.status,statusText:d.statusText,headers:n,config:t,request:d};i(e,u,o),d=null}},d.onerror=function(){u(c("Network Error",t,null,d)),d=null},d.ontimeout=function(){u(c("timeout of "+t.timeout+"ms exceeded",t,"ECONNABORTED",d)),d=null},r.isStandardBrowserEnv()){var v=n("7aac"),m=(t.withCredentials||s(t.url))&&t.xsrfCookieName?v.read(t.xsrfCookieName):void 0;m&&(f[t.xsrfHeaderName]=m)}if("setRequestHeader"in d&&r.forEach(f,(function(t,e){"undefined"===typeof l&&"content-type"===e.toLowerCase()?delete f[e]:d.setRequestHeader(e,t)})),t.withCredentials&&(d.withCredentials=!0),t.responseType)try{d.responseType=t.responseType}catch(g){if("json"!==t.responseType)throw g}"function"===typeof t.onDownloadProgress&&d.addEventListener("progress",t.onDownloadProgress),"function"===typeof t.onUploadProgress&&d.upload&&d.upload.addEventListener("progress",t.onUploadProgress),t.cancelToken&&t.cancelToken.promise.then((function(t){d&&(d.abort(),u(t),d=null)})),void 0===l&&(l=null),d.send(l)}))}},b575:function(t,e,n){var r,i,o,a,s,c,u,l,f=n("da84"),d=n("06cf").f,p=n("2cf4").set,h=n("1cdc"),v=n("a4b4"),m=n("605d"),g=f.MutationObserver||f.WebKitMutationObserver,b=f.document,y=f.process,x=f.Promise,w=d(f,"queueMicrotask"),_=w&&w.value;_||(r=function(){var t,e;m&&(t=y.domain)&&t.exit();while(i){e=i.fn,i=i.next;try{e()}catch(n){throw i?a():o=void 0,n}}o=void 0,t&&t.enter()},h||m||v||!g||!b?x&&x.resolve?(u=x.resolve(void 0),u.constructor=x,l=u.then,a=function(){l.call(u,r)}):a=m?function(){y.nextTick(r)}:function(){p.call(f,r)}:(s=!0,c=b.createTextNode(""),new g(r).observe(c,{characterData:!0}),a=function(){c.data=s=!s})),t.exports=_||function(t){var e={fn:t,next:void 0};o&&(o.next=e),i||(i=e,a()),o=e}},b622:function(t,e,n){var r=n("da84"),i=n("5692"),o=n("5135"),a=n("90e3"),s=n("4930"),c=n("fdbf"),u=i("wks"),l=r.Symbol,f=c?l:l&&l.withoutSetter||a;t.exports=function(t){return o(u,t)&&(s||"string"==typeof u[t])||(s&&o(l,t)?u[t]=l[t]:u[t]=f("Symbol."+t)),u[t]}},b64b:function(t,e,n){var r=n("23e7"),i=n("7b0b"),o=n("df75"),a=n("d039"),s=a((function(){o(1)}));r({target:"Object",stat:!0,forced:s},{keys:function(t){return o(i(t))}})},b680:function(t,e,n){"use strict";var r=n("23e7"),i=n("a691"),o=n("408a"),a=n("1148"),s=n("d039"),c=1..toFixed,u=Math.floor,l=function(t,e,n){return 0===e?n:e%2===1?l(t,e-1,n*t):l(t*t,e/2,n)},f=function(t){var e=0,n=t;while(n>=4096)e+=12,n/=4096;while(n>=2)e+=1,n/=2;return e},d=function(t,e,n){var r=-1,i=n;while(++r<6)i+=e*t[r],t[r]=i%1e7,i=u(i/1e7)},p=function(t,e){var n=6,r=0;while(--n>=0)r+=t[n],t[n]=u(r/e),r=r%e*1e7},h=function(t){var e=6,n="";while(--e>=0)if(""!==n||0===e||0!==t[e]){var r=String(t[e]);n=""===n?r:n+a.call("0",7-r.length)+r}return n},v=c&&("0.000"!==8e-5.toFixed(3)||"1"!==.9.toFixed(0)||"1.25"!==1.255.toFixed(2)||"1000000000000000128"!==(0xde0b6b3a7640080).toFixed(0))||!s((function(){c.call({})}));r({target:"Number",proto:!0,forced:v},{toFixed:function(t){var e,n,r,s,c=o(this),u=i(t),v=[0,0,0,0,0,0],m="",g="0";if(u<0||u>20)throw RangeError("Incorrect fraction digits");if(c!=c)return"NaN";if(c<=-1e21||c>=1e21)return String(c);if(c<0&&(m="-",c=-c),c>1e-21)if(e=f(c*l(2,69,1))-69,n=e<0?c*l(2,-e,1):c/l(2,e,1),n*=4503599627370496,e=52-e,e>0){d(v,0,n),r=u;while(r>=7)d(v,1e7,0),r-=7;d(v,l(10,r,1),0),r=e-1;while(r>=23)p(v,1<<23),r-=23;p(v,1<0?(s=g.length,g=m+(s<=u?"0."+a.call("0",u-s)+g:g.slice(0,s-u)+"."+g.slice(s-u))):g=m+g,g}})},b727:function(t,e,n){var r=n("0366"),i=n("44ad"),o=n("7b0b"),a=n("50c4"),s=n("65f0"),c=[].push,u=function(t){var e=1==t,n=2==t,u=3==t,l=4==t,f=6==t,d=7==t,p=5==t||f;return function(h,v,m,g){for(var b,y,x=o(h),w=i(x),_=r(v,m,3),S=a(w.length),O=0,C=g||s,k=e?C(h,S):n||d?C(h,0):void 0;S>O;O++)if((p||O in w)&&(b=w[O],y=_(b,O,x),t))if(e)k[O]=y;else if(y)switch(t){case 3:return!0;case 5:return b;case 6:return O;case 2:c.call(k,b)}else switch(t){case 4:return!1;case 7:c.call(k,b)}return f?-1:u||l?l:k}};t.exports={forEach:u(0),map:u(1),filter:u(2),some:u(3),every:u(4),find:u(5),findIndex:u(6),filterOut:u(7)}},b85c:function(t,e,n){"use strict";n.d(e,"a",(function(){return i}));n("a4d3"),n("e01a"),n("d3b7"),n("d28b"),n("3ca3"),n("ddb0");var r=n("06c5");function i(t,e){var n="undefined"!==typeof Symbol&&t[Symbol.iterator]||t["@@iterator"];if(!n){if(Array.isArray(t)||(n=Object(r["a"])(t))||e&&t&&"number"===typeof t.length){n&&(t=n);var i=0,o=function(){};return{s:o,n:function(){return i>=t.length?{done:!0}:{done:!1,value:t[i++]}},e:function(t){throw t},f:o}}throw new TypeError("Invalid attempt to iterate non-iterable instance.\nIn order to be iterable, non-array objects must have a [Symbol.iterator]() method.")}var a,s=!0,c=!1;return{s:function(){n=n.call(t)},n:function(){var t=n.next();return s=t.done,t},e:function(t){c=!0,a=t},f:function(){try{s||null==n["return"]||n["return"]()}finally{if(c)throw a}}}}},bb2f:function(t,e,n){var r=n("d039");t.exports=!r((function(){return Object.isExtensible(Object.preventExtensions({}))}))},bc3a:function(t,e,n){t.exports=n("cee4")},bd0c:function(t,e,n){},c04e:function(t,e,n){var r=n("861d");t.exports=function(t,e){if(!r(t))return t;var n,i;if(e&&"function"==typeof(n=t.toString)&&!r(i=n.call(t)))return i;if("function"==typeof(n=t.valueOf)&&!r(i=n.call(t)))return i;if(!e&&"function"==typeof(n=t.toString)&&!r(i=n.call(t)))return i;throw TypeError("Can't convert object to primitive value")}},c345:function(t,e,n){"use strict";var r=n("c532"),i=["age","authorization","content-length","content-type","etag","expires","from","host","if-modified-since","if-unmodified-since","last-modified","location","max-forwards","proxy-authorization","referer","retry-after","user-agent"];t.exports=function(t){var e,n,o,a={};return t?(r.forEach(t.split("\n"),(function(t){if(o=t.indexOf(":"),e=r.trim(t.substr(0,o)).toLowerCase(),n=r.trim(t.substr(o+1)),e){if(a[e]&&i.indexOf(e)>=0)return;a[e]="set-cookie"===e?(a[e]?a[e]:[]).concat([n]):a[e]?a[e]+", "+n:n}})),a):a}},c401:function(t,e,n){"use strict";var r=n("c532");t.exports=function(t,e,n){return r.forEach(n,(function(n){t=n(t,e)})),t}},c430:function(t,e){t.exports=!1},c532:function(t,e,n){"use strict";var r=n("1d2b"),i=n("c7ce"),o=Object.prototype.toString;function a(t){return"[object Array]"===o.call(t)}function s(t){return"[object ArrayBuffer]"===o.call(t)}function c(t){return"undefined"!==typeof FormData&&t instanceof FormData}function u(t){var e;return e="undefined"!==typeof ArrayBuffer&&ArrayBuffer.isView?ArrayBuffer.isView(t):t&&t.buffer&&t.buffer instanceof ArrayBuffer,e}function l(t){return"string"===typeof t}function f(t){return"number"===typeof t}function d(t){return"undefined"===typeof t}function p(t){return null!==t&&"object"===typeof t}function h(t){return"[object Date]"===o.call(t)}function v(t){return"[object File]"===o.call(t)}function m(t){return"[object Blob]"===o.call(t)}function g(t){return"[object Function]"===o.call(t)}function b(t){return p(t)&&g(t.pipe)}function y(t){return"undefined"!==typeof URLSearchParams&&t instanceof URLSearchParams}function x(t){return t.replace(/^\s*/,"").replace(/\s*$/,"")}function w(){return("undefined"===typeof navigator||"ReactNative"!==navigator.product)&&("undefined"!==typeof window&&"undefined"!==typeof document)}function _(t,e){if(null!==t&&"undefined"!==typeof t)if("object"!==typeof t&&(t=[t]),a(t))for(var n=0,r=t.length;n - * @license MIT - */ -t.exports=function(t){return null!=t&&null!=t.constructor&&"function"===typeof t.constructor.isBuffer&&t.constructor.isBuffer(t)}},c8af:function(t,e,n){"use strict";var r=n("c532");t.exports=function(t,e){r.forEach(t,(function(n,r){r!==e&&r.toUpperCase()===e.toUpperCase()&&(t[e]=n,delete t[r])}))}},c8ba:function(t,e){var n;n=function(){return this}();try{n=n||new Function("return this")()}catch(r){"object"===typeof window&&(n=window)}t.exports=n},c8d2:function(t,e,n){var r=n("d039"),i=n("5899"),o="​…᠎";t.exports=function(t){return r((function(){return!!i[t]()||o[t]()!=o||i[t].name!==t}))}},c96a:function(t,e,n){"use strict";var r=n("23e7"),i=n("857a"),o=n("af03");r({target:"String",proto:!0,forced:o("small")},{small:function(){return i(this,"small","","")}})},c995:function(t,e,n){"use strict";var r=n("ade3"),i=(n("a9e3"),n("2b0e"));e["a"]=i["a"].extend({name:"elevatable",props:{elevation:[Number,String]},computed:{computedElevation:function(){return this.elevation},elevationClasses:function(){var t=this.computedElevation;return null==t||isNaN(parseInt(t))?{}:Object(r["a"])({},"elevation-".concat(this.elevation),!0)}}})},ca84:function(t,e,n){var r=n("5135"),i=n("fc6a"),o=n("4d64").indexOf,a=n("d012");t.exports=function(t,e){var n,s=i(t),c=0,u=[];for(n in s)!r(a,n)&&r(s,n)&&u.push(n);while(e.length>c)r(s,n=e[c++])&&(~o(u,n)||u.push(n));return u}},caad:function(t,e,n){"use strict";var r=n("23e7"),i=n("4d64").includes,o=n("44d2");r({target:"Array",proto:!0},{includes:function(t){return i(this,t,arguments.length>1?arguments[1]:void 0)}}),o("includes")},cb29:function(t,e,n){var r=n("23e7"),i=n("81d5"),o=n("44d2");r({target:"Array",proto:!0},{fill:i}),o("fill")},cc12:function(t,e,n){var r=n("da84"),i=n("861d"),o=r.document,a=i(o)&&i(o.createElement);t.exports=function(t){return a?o.createElement(t):{}}},cca6:function(t,e,n){var r=n("23e7"),i=n("60da");r({target:"Object",stat:!0,forced:Object.assign!==i},{assign:i})},cdf9:function(t,e,n){var r=n("825a"),i=n("861d"),o=n("f069");t.exports=function(t,e){if(r(t),i(e)&&e.constructor===t)return e;var n=o.f(t),a=n.resolve;return a(e),n.promise}},ce4e:function(t,e,n){var r=n("da84"),i=n("9112");t.exports=function(t,e){try{i(r,t,e)}catch(n){r[t]=e}return e}},cee4:function(t,e,n){"use strict";var r=n("c532"),i=n("1d2b"),o=n("0a06"),a=n("2444");function s(t){var e=new o(t),n=i(o.prototype.request,e);return r.extend(n,o.prototype,e),r.extend(n,e),n}var c=s(a);c.Axios=o,c.create=function(t){return s(r.merge(a,t))},c.Cancel=n("7a77"),c.CancelToken=n("8df4"),c.isCancel=n("2e67"),c.all=function(t){return Promise.all(t)},c.spread=n("0df6"),t.exports=c,t.exports.default=c},d012:function(t,e){t.exports={}},d039:function(t,e){t.exports=function(t){try{return!!t()}catch(e){return!0}}},d066:function(t,e,n){var r=n("428f"),i=n("da84"),o=function(t){return"function"==typeof t?t:void 0};t.exports=function(t,e){return arguments.length<2?o(r[t])||o(i[t]):r[t]&&r[t][e]||i[t]&&i[t][e]}},d10f:function(t,e,n){"use strict";var r=n("2b0e");e["a"]=r["a"].extend({name:"ssr-bootable",data:function(){return{isBooted:!1}},mounted:function(){var t=this;window.requestAnimationFrame((function(){t.$el.setAttribute("data-booted","true"),t.isBooted=!0}))}})},d1e7:function(t,e,n){"use strict";var r={}.propertyIsEnumerable,i=Object.getOwnPropertyDescriptor,o=i&&!r.call({1:2},1);e.f=o?function(t){var e=i(this,t);return!!e&&e.enumerable}:r},d28b:function(t,e,n){var r=n("746f");r("iterator")},d2bb:function(t,e,n){var r=n("825a"),i=n("3bbe");t.exports=Object.setPrototypeOf||("__proto__"in{}?function(){var t,e=!1,n={};try{t=Object.getOwnPropertyDescriptor(Object.prototype,"__proto__").set,t.call(n,[]),e=n instanceof Array}catch(o){}return function(n,o){return r(n),i(o),e?t.call(n,o):n.__proto__=o,n}}():void 0)},d3b7:function(t,e,n){var r=n("00ee"),i=n("6eeb"),o=n("b041");r||i(Object.prototype,"toString",o,{unsafe:!0})},d44e:function(t,e,n){var r=n("9bf2").f,i=n("5135"),o=n("b622"),a=o("toStringTag");t.exports=function(t,e,n){t&&!i(t=n?t:t.prototype,a)&&r(t,a,{configurable:!0,value:e})}},d784:function(t,e,n){"use strict";n("ac1f");var r=n("6eeb"),i=n("9263"),o=n("d039"),a=n("b622"),s=n("9112"),c=a("species"),u=RegExp.prototype,l=!o((function(){var t=/./;return t.exec=function(){var t=[];return t.groups={a:"7"},t},"7"!=="".replace(t,"$")})),f=function(){return"$0"==="a".replace(/./,"$0")}(),d=a("replace"),p=function(){return!!/./[d]&&""===/./[d]("a","$0")}(),h=!o((function(){var t=/(?:)/,e=t.exec;t.exec=function(){return e.apply(this,arguments)};var n="ab".split(t);return 2!==n.length||"a"!==n[0]||"b"!==n[1]}));t.exports=function(t,e,n,d){var v=a(t),m=!o((function(){var e={};return e[v]=function(){return 7},7!=""[t](e)})),g=m&&!o((function(){var e=!1,n=/a/;return"split"===t&&(n={},n.constructor={},n.constructor[c]=function(){return n},n.flags="",n[v]=/./[v]),n.exec=function(){return e=!0,null},n[v](""),!e}));if(!m||!g||"replace"===t&&(!l||!f||p)||"split"===t&&!h){var b=/./[v],y=n(v,""[t],(function(t,e,n,r,o){var a=e.exec;return a===i||a===u.exec?m&&!o?{done:!0,value:b.call(e,n,r)}:{done:!0,value:t.call(n,e,r)}:{done:!1}}),{REPLACE_KEEPS_$0:f,REGEXP_REPLACE_SUBSTITUTES_UNDEFINED_CAPTURE:p}),x=y[0],w=y[1];r(String.prototype,t,x),r(u,v,2==e?function(t,e){return w.call(t,this,e)}:function(t){return w.call(t,this)})}d&&s(u[v],"sham",!0)}},d81d:function(t,e,n){"use strict";var r=n("23e7"),i=n("b727").map,o=n("1dde"),a=o("map");r({target:"Array",proto:!0,forced:!a},{map:function(t){return i(this,t,arguments.length>1?arguments[1]:void 0)}})},d925:function(t,e,n){"use strict";t.exports=function(t){return/^([a-z][a-z\d\+\-\.]*:)?\/\//i.test(t)}},d9bd:function(t,e,n){"use strict";n.d(e,"c",(function(){return o})),n.d(e,"b",(function(){return a})),n.d(e,"a",(function(){return s}));n("caad"),n("2532"),n("99af"),n("ac1f"),n("5319"),n("b0c0"),n("466d"),n("a15b"),n("d81d"),n("38cf");var r=n("f309");function i(t,e,n){if(!r["a"].config.silent){if(n&&(e={_isVue:!0,$parent:n,$options:e}),e){if(e.$_alreadyWarned=e.$_alreadyWarned||[],e.$_alreadyWarned.includes(t))return;e.$_alreadyWarned.push(t)}return"[Vuetify] ".concat(t)+(e?f(e):"")}}function o(t,e,n){var r=i(t,e,n);null!=r&&console.warn(r)}function a(t,e,n){var r=i(t,e,n);null!=r&&console.error(r)}function s(t,e,n,r){a("[BREAKING] '".concat(t,"' has been removed, use '").concat(e,"' instead. For more information, see the upgrade guide https://github.com/vuetifyjs/vuetify/releases/tag/v2.0.0#user-content-upgrade-guide"),n,r)}var c=/(?:^|[-_])(\w)/g,u=function(t){return t.replace(c,(function(t){return t.toUpperCase()})).replace(/[-_]/g,"")};function l(t,e){if(t.$root===t)return"";var n="function"===typeof t&&null!=t.cid?t.options:t._isVue?t.$options||t.constructor.options:t||{},r=n.name||n._componentTag,i=n.__file;if(!r&&i){var o=i.match(/([^/\\]+)\.vue$/);r=o&&o[1]}return(r?"<".concat(u(r),">"):"")+(i&&!1!==e?" at ".concat(i):"")}function f(t){if(t._isVue&&t.$parent){var e=[],n=0;while(t){if(e.length>0){var r=e[e.length-1];if(r.constructor===t.constructor){n++,t=t.$parent;continue}n>0&&(e[e.length-1]=[r,n],n=0)}e.push(t),t=t.$parent}return"\n\nfound in\n\n"+e.map((function(t,e){return"".concat(0===e?"---\x3e ":" ".repeat(5+2*e)).concat(Array.isArray(t)?"".concat(l(t[0]),"... (").concat(t[1]," recursive calls)"):l(t))})).join("\n")}return"\n\n(found in ".concat(l(t),")")}},d9f7:function(t,e,n){"use strict";n.d(e,"a",(function(){return u}));var r=n("5530"),i=n("3835"),o=n("b85c"),a=(n("ac1f"),n("1276"),n("498a"),n("b64b"),n("99af"),n("80d2")),s={styleList:/;(?![^(]*\))/g,styleProp:/:(.*)/};function c(t){var e,n={},r=Object(o["a"])(t.split(s.styleList));try{for(r.s();!(e=r.n()).done;){var c=e.value,u=c.split(s.styleProp),l=Object(i["a"])(u,2),f=l[0],d=l[1];f=f.trim(),f&&("string"===typeof d&&(d=d.trim()),n[Object(a["a"])(f)]=d)}}catch(p){r.e(p)}finally{r.f()}return n}function u(){var t,e={},n=arguments.length;while(n--)for(var i=0,o=Object.keys(arguments[n]);if)n=i(r,e=u[f++]),void 0!==n&&c(l,e,n);return l}})},dca8:function(t,e,n){var r=n("23e7"),i=n("bb2f"),o=n("d039"),a=n("861d"),s=n("f183").onFreeze,c=Object.freeze,u=o((function(){c(1)}));r({target:"Object",stat:!0,forced:u,sham:!i},{freeze:function(t){return c&&a(t)?c(s(t)):t}})},ddb0:function(t,e,n){var r=n("da84"),i=n("fdbc"),o=n("e260"),a=n("9112"),s=n("b622"),c=s("iterator"),u=s("toStringTag"),l=o.values;for(var f in i){var d=r[f],p=d&&d.prototype;if(p){if(p[c]!==l)try{a(p,c,l)}catch(v){p[c]=l}if(p[u]||a(p,u,f),i[f])for(var h in o)if(p[h]!==o[h])try{a(p,h,o[h])}catch(v){p[h]=o[h]}}}},df75:function(t,e,n){var r=n("ca84"),i=n("7839");t.exports=Object.keys||function(t){return r(t,i)}},df86:function(t,e,n){},e01a:function(t,e,n){"use strict";var r=n("23e7"),i=n("83ab"),o=n("da84"),a=n("5135"),s=n("861d"),c=n("9bf2").f,u=n("e893"),l=o.Symbol;if(i&&"function"==typeof l&&(!("description"in l.prototype)||void 0!==l().description)){var f={},d=function(){var t=arguments.length<1||void 0===arguments[0]?void 0:String(arguments[0]),e=this instanceof d?new l(t):void 0===t?l():l(t);return""===t&&(f[e]=!0),e};u(d,l);var p=d.prototype=l.prototype;p.constructor=d;var h=p.toString,v="Symbol(test)"==String(l("test")),m=/^Symbol\((.*)\)[^)]+$/;c(p,"description",{configurable:!0,get:function(){var t=s(this)?this.valueOf():this,e=h.call(t);if(a(f,t))return"";var n=v?e.slice(7,-1):e.replace(m,"$1");return""===n?void 0:n}}),r({global:!0,forced:!0},{Symbol:d})}},e163:function(t,e,n){var r=n("5135"),i=n("7b0b"),o=n("f772"),a=n("e177"),s=o("IE_PROTO"),c=Object.prototype;t.exports=a?Object.getPrototypeOf:function(t){return t=i(t),r(t,s)?t[s]:"function"==typeof t.constructor&&t instanceof t.constructor?t.constructor.prototype:t instanceof Object?c:null}},e177:function(t,e,n){var r=n("d039");t.exports=!r((function(){function t(){}return t.prototype.constructor=null,Object.getPrototypeOf(new t)!==t.prototype}))},e260:function(t,e,n){"use strict";var r=n("fc6a"),i=n("44d2"),o=n("3f8c"),a=n("69f3"),s=n("7dd0"),c="Array Iterator",u=a.set,l=a.getterFor(c);t.exports=s(Array,"Array",(function(t,e){u(this,{type:c,target:r(t),index:0,kind:e})}),(function(){var t=l(this),e=t.target,n=t.kind,r=t.index++;return!e||r>=e.length?(t.target=void 0,{value:void 0,done:!0}):"keys"==n?{value:r,done:!1}:"values"==n?{value:e[r],done:!1}:{value:[r,e[r]],done:!1}}),"values"),o.Arguments=o.Array,i("keys"),i("values"),i("entries")},e2cc:function(t,e,n){var r=n("6eeb");t.exports=function(t,e,n){for(var i in e)r(t,i,e[i],n);return t}},e439:function(t,e,n){var r=n("23e7"),i=n("d039"),o=n("fc6a"),a=n("06cf").f,s=n("83ab"),c=i((function(){a(1)})),u=!s||c;r({target:"Object",stat:!0,forced:u,sham:!s},{getOwnPropertyDescriptor:function(t,e){return a(o(t),e)}})},e538:function(t,e,n){var r=n("b622");e.f=r},e667:function(t,e){t.exports=function(t){try{return{error:!1,value:t()}}catch(e){return{error:!0,value:e}}}},e683:function(t,e,n){"use strict";t.exports=function(t,e){return e?t.replace(/\/+$/,"")+"/"+e.replace(/^\/+/,""):t}},e6cf:function(t,e,n){"use strict";var r,i,o,a,s=n("23e7"),c=n("c430"),u=n("da84"),l=n("d066"),f=n("fea9"),d=n("6eeb"),p=n("e2cc"),h=n("d2bb"),v=n("d44e"),m=n("2626"),g=n("861d"),b=n("1c0b"),y=n("19aa"),x=n("8925"),w=n("2266"),_=n("1c7e"),S=n("4840"),O=n("2cf4").set,C=n("b575"),k=n("cdf9"),j=n("44de"),L=n("f069"),E=n("e667"),A=n("69f3"),$=n("94ca"),T=n("b622"),P=n("6069"),M=n("605d"),I=n("2d00"),N=T("species"),B="Promise",R=A.get,D=A.set,F=A.getterFor(B),H=f&&f.prototype,z=f,V=H,U=u.TypeError,W=u.document,q=u.process,Z=L.f,G=Z,K=!!(W&&W.createEvent&&u.dispatchEvent),X="function"==typeof PromiseRejectionEvent,Y="unhandledrejection",Q="rejectionhandled",J=0,tt=1,et=2,nt=1,rt=2,it=!1,ot=$(B,(function(){var t=x(z)!==String(z);if(!t&&66===I)return!0;if(c&&!V["finally"])return!0;if(I>=51&&/native code/.test(z))return!1;var e=new z((function(t){t(1)})),n=function(t){t((function(){}),(function(){}))},r=e.constructor={};return r[N]=n,it=e.then((function(){}))instanceof n,!it||!t&&P&&!X})),at=ot||!_((function(t){z.all(t)["catch"]((function(){}))})),st=function(t){var e;return!(!g(t)||"function"!=typeof(e=t.then))&&e},ct=function(t,e){if(!t.notified){t.notified=!0;var n=t.reactions;C((function(){var r=t.value,i=t.state==tt,o=0;while(n.length>o){var a,s,c,u=n[o++],l=i?u.ok:u.fail,f=u.resolve,d=u.reject,p=u.domain;try{l?(i||(t.rejection===rt&&dt(t),t.rejection=nt),!0===l?a=r:(p&&p.enter(),a=l(r),p&&(p.exit(),c=!0)),a===u.promise?d(U("Promise-chain cycle")):(s=st(a))?s.call(a,f,d):f(a)):d(r)}catch(h){p&&!c&&p.exit(),d(h)}}t.reactions=[],t.notified=!1,e&&!t.rejection&<(t)}))}},ut=function(t,e,n){var r,i;K?(r=W.createEvent("Event"),r.promise=e,r.reason=n,r.initEvent(t,!1,!0),u.dispatchEvent(r)):r={promise:e,reason:n},!X&&(i=u["on"+t])?i(r):t===Y&&j("Unhandled promise rejection",n)},lt=function(t){O.call(u,(function(){var e,n=t.facade,r=t.value,i=ft(t);if(i&&(e=E((function(){M?q.emit("unhandledRejection",r,n):ut(Y,n,r)})),t.rejection=M||ft(t)?rt:nt,e.error))throw e.value}))},ft=function(t){return t.rejection!==nt&&!t.parent},dt=function(t){O.call(u,(function(){var e=t.facade;M?q.emit("rejectionHandled",e):ut(Q,e,t.value)}))},pt=function(t,e,n){return function(r){t(e,r,n)}},ht=function(t,e,n){t.done||(t.done=!0,n&&(t=n),t.value=e,t.state=et,ct(t,!0))},vt=function(t,e,n){if(!t.done){t.done=!0,n&&(t=n);try{if(t.facade===e)throw U("Promise can't be resolved itself");var r=st(e);r?C((function(){var n={done:!1};try{r.call(e,pt(vt,n,t),pt(ht,n,t))}catch(i){ht(n,i,t)}})):(t.value=e,t.state=tt,ct(t,!1))}catch(i){ht({done:!1},i,t)}}};if(ot&&(z=function(t){y(this,z,B),b(t),r.call(this);var e=R(this);try{t(pt(vt,e),pt(ht,e))}catch(n){ht(e,n)}},V=z.prototype,r=function(t){D(this,{type:B,done:!1,notified:!1,parent:!1,reactions:[],rejection:!1,state:J,value:void 0})},r.prototype=p(V,{then:function(t,e){var n=F(this),r=Z(S(this,z));return r.ok="function"!=typeof t||t,r.fail="function"==typeof e&&e,r.domain=M?q.domain:void 0,n.parent=!0,n.reactions.push(r),n.state!=J&&ct(n,!1),r.promise},catch:function(t){return this.then(void 0,t)}}),i=function(){var t=new r,e=R(t);this.promise=t,this.resolve=pt(vt,e),this.reject=pt(ht,e)},L.f=Z=function(t){return t===z||t===o?new i(t):G(t)},!c&&"function"==typeof f&&H!==Object.prototype)){a=H.then,it||(d(H,"then",(function(t,e){var n=this;return new z((function(t,e){a.call(n,t,e)})).then(t,e)}),{unsafe:!0}),d(H,"catch",V["catch"],{unsafe:!0}));try{delete H.constructor}catch(mt){}h&&h(H,V)}s({global:!0,wrap:!0,forced:ot},{Promise:z}),v(z,B,!1,!0),m(B),o=l(B),s({target:B,stat:!0,forced:ot},{reject:function(t){var e=Z(this);return e.reject.call(void 0,t),e.promise}}),s({target:B,stat:!0,forced:c||ot},{resolve:function(t){return k(c&&this===o?z:this,t)}}),s({target:B,stat:!0,forced:at},{all:function(t){var e=this,n=Z(e),r=n.resolve,i=n.reject,o=E((function(){var n=b(e.resolve),o=[],a=0,s=1;w(t,(function(t){var c=a++,u=!1;o.push(void 0),s++,n.call(e,t).then((function(t){u||(u=!0,o[c]=t,--s||r(o))}),i)})),--s||r(o)}));return o.error&&i(o.value),n.promise},race:function(t){var e=this,n=Z(e),r=n.reject,i=E((function(){var i=b(e.resolve);w(t,(function(t){i.call(e,t).then(n.resolve,r)}))}));return i.error&&r(i.value),n.promise}})},e893:function(t,e,n){var r=n("5135"),i=n("56ef"),o=n("06cf"),a=n("9bf2");t.exports=function(t,e){for(var n=i(e),s=a.f,c=o.f,u=0;u1)for(var n=1;n0&&void 0!==arguments[0]?arguments[0]:"value",n=arguments.length>1&&void 0!==arguments[1]?arguments[1]:"input";return i["a"].extend({name:"toggleable",model:{prop:e,event:n},props:Object(r["a"])({},e,{required:!1}),data:function(){return{isActive:!!this[e]}},watch:(t={},Object(r["a"])(t,e,(function(t){this.isActive=!!t})),Object(r["a"])(t,"isActive",(function(t){!!t!==this[e]&&this.$emit(n,t)})),t)})}var a=o();e["a"]=a},f309:function(t,e,n){"use strict";n.d(e,"a",(function(){return Tt}));var r={};function i(t,e){if(!(t instanceof e))throw new TypeError("Cannot call a class as a function")}function o(t,e){for(var n=0;n1&&void 0!==arguments[1]?arguments[1]:{};if(!u.installed){u.installed=!0,s["a"]!==t&&Object(c["b"])("Multiple instances of Vue detected\nSee https://github.com/vuetifyjs/vuetify/issues/4068\n\nIf you're seeing \"$attrs is readonly\", it's caused by this");var n=e.components||{},r=e.directives||{};for(var i in r){var o=r[i];t.directive(i,o)}(function e(n){if(n){for(var r in n){var i=n[r];i&&!e(i.$_vuetify_subcomponents)&&t.component(r,i)}return!0}return!1})(n),t.$_vuetify_installed||(t.$_vuetify_installed=!0,t.mixin({beforeCreate:function(){var e=this.$options;e.vuetify?(e.vuetify.init(this,this.$ssrContext),this.$vuetify=t.observable(e.vuetify.framework)):this.$vuetify=e.parent&&e.parent.$vuetify||this},beforeMount:function(){this.$options.vuetify&&this.$el&&this.$el.hasAttribute("data-server-rendered")&&(this.$vuetify.isHydrating=!0,this.$vuetify.breakpoint.update(!0))},mounted:function(){this.$options.vuetify&&this.$vuetify.isHydrating&&(this.$vuetify.isHydrating=!1,this.$vuetify.breakpoint.update())}}))}}n("a4d3"),n("b64b");function l(t,e){if(null==t)return{};var n,r,i={},o=Object.keys(t);for(r=0;r=0||(i[n]=t[n]);return i}function f(t,e){if(null==t)return{};var n,r,i=l(t,e);if(Object.getOwnPropertySymbols){var o=Object.getOwnPropertySymbols(t);for(r=0;r=0||Object.prototype.propertyIsEnumerable.call(t,n)&&(i[n]=t[n])}return i}function d(t,e){return d=Object.setPrototypeOf||function(t,e){return t.__proto__=e,t},d(t,e)}function p(t,e){if("function"!==typeof e&&null!==e)throw new TypeError("Super expression must either be null or a function");t.prototype=Object.create(e&&e.prototype,{constructor:{value:t,writable:!0,configurable:!0}}),e&&d(t,e)}n("4ae1"),n("3410");function h(t){return h=Object.setPrototypeOf?Object.getPrototypeOf:function(t){return t.__proto__||Object.getPrototypeOf(t)},h(t)}function v(){if("undefined"===typeof Reflect||!Reflect.construct)return!1;if(Reflect.construct.sham)return!1;if("function"===typeof Proxy)return!0;try{return Boolean.prototype.valueOf.call(Reflect.construct(Boolean,[],(function(){}))),!0}catch(t){return!1}}var m=n("7037"),g=n.n(m);function b(t){if(void 0===t)throw new ReferenceError("this hasn't been initialised - super() hasn't been called");return t}function y(t,e){return!e||"object"!==g()(e)&&"function"!==typeof e?b(t):e}function x(t){var e=v();return function(){var n,r=h(t);if(e){var i=h(this).constructor;n=Reflect.construct(r,arguments,i)}else n=r.apply(this,arguments);return y(this,n)}}n("95ed");var w={badge:"Badge",close:"Close",dataIterator:{noResultsText:"No matching records found",loadingText:"Loading items..."},dataTable:{itemsPerPageText:"Rows per page:",ariaLabel:{sortDescending:"Sorted descending.",sortAscending:"Sorted ascending.",sortNone:"Not sorted.",activateNone:"Activate to remove sorting.",activateDescending:"Activate to sort descending.",activateAscending:"Activate to sort ascending."},sortBy:"Sort by"},dataFooter:{itemsPerPageText:"Items per page:",itemsPerPageAll:"All",nextPage:"Next page",prevPage:"Previous page",firstPage:"First page",lastPage:"Last page",pageText:"{0}-{1} of {2}"},datePicker:{itemsSelected:"{0} selected",nextMonthAriaLabel:"Next month",nextYearAriaLabel:"Next year",prevMonthAriaLabel:"Previous month",prevYearAriaLabel:"Previous year"},noDataText:"No data available",carousel:{prev:"Previous visual",next:"Next visual",ariaLabel:{delimiter:"Carousel slide {0} of {1}"}},calendar:{moreEvents:"{0} more"},fileInput:{counter:"{0} files",counterSize:"{0} files ({1} in total)"},timePicker:{am:"AM",pm:"PM"},pagination:{ariaLabel:{wrapper:"Pagination Navigation",next:"Next page",previous:"Previous page",page:"Goto Page {0}",currentPage:"Current Page, Page {0}"}},rating:{ariaLabel:{icon:"Rating {0} of {1}"}}},_={breakpoint:{mobileBreakpoint:1264,scrollBarWidth:16,thresholds:{xs:600,sm:960,md:1280,lg:1920}},icons:{iconfont:"mdi",values:{}},lang:{current:"en",locales:{en:w},t:void 0},rtl:!1,theme:{dark:!1,default:"light",disable:!1,options:{cspNonce:void 0,customProperties:void 0,minifyTheme:void 0,themeCache:void 0,variations:!0},themes:{light:{primary:"#1976D2",secondary:"#424242",accent:"#82B1FF",error:"#FF5252",info:"#2196F3",success:"#4CAF50",warning:"#FB8C00"},dark:{primary:"#2196F3",secondary:"#424242",accent:"#FF4081",error:"#FF5252",info:"#2196F3",success:"#4CAF50",warning:"#FB8C00"}}}},S=n("80d2"),O=function(){function t(){i(this,t),this.framework={}}return a(t,[{key:"init",value:function(t,e){}}]),t}(),C=function(t){p(n,t);var e=x(n);function n(t,r){var o;i(this,n),o=e.call(this);var a=Object(S["l"])({},_),s=r.userPreset,u=s.preset,l=void 0===u?{}:u,d=f(s,["preset"]);return null!=l.preset&&Object(c["c"])("Global presets do not support the **preset** option, it can be safely omitted"),r.preset=Object(S["l"])(Object(S["l"])(a,l),d),o}return n}(O);C.property="presets";var k=n("ade3"),j=(n("07ac"),function(t){p(n,t);var e=x(n);function n(){var t;return i(this,n),t=e.apply(this,arguments),t.bar=0,t.top=0,t.left=0,t.insetFooter=0,t.right=0,t.bottom=0,t.footer=0,t.application={bar:{},top:{},left:{},insetFooter:{},right:{},bottom:{},footer:{}},t}return a(n,[{key:"register",value:function(t,e,n){this.application[e]=Object(k["a"])({},t,n),this.update(e)}},{key:"unregister",value:function(t,e){null!=this.application[e][t]&&(delete this.application[e][t],this.update(e))}},{key:"update",value:function(t){this[t]=Object.values(this.application[t]).reduce((function(t,e){return t+e}),0)}}]),n}(O));j.property="application";n("b0c0");var L=function(t){p(n,t);var e=x(n);function n(t){var r;i(this,n),r=e.call(this),r.xs=!1,r.sm=!1,r.md=!1,r.lg=!1,r.xl=!1,r.xsOnly=!1,r.smOnly=!1,r.smAndDown=!1,r.smAndUp=!1,r.mdOnly=!1,r.mdAndDown=!1,r.mdAndUp=!1,r.lgOnly=!1,r.lgAndDown=!1,r.lgAndUp=!1,r.xlOnly=!1,r.name="xs",r.height=0,r.width=0,r.mobile=!0,r.resizeTimeout=0;var o=t[n.property],a=o.mobileBreakpoint,s=o.scrollBarWidth,c=o.thresholds;return r.mobileBreakpoint=a,r.scrollBarWidth=s,r.thresholds=c,r}return a(n,[{key:"init",value:function(){this.update(),"undefined"!==typeof window&&window.addEventListener("resize",this.onResize.bind(this),{passive:!0})}},{key:"update",value:function(){var t=arguments.length>0&&void 0!==arguments[0]&&arguments[0],e=t?0:this.getClientHeight(),n=t?0:this.getClientWidth(),r=n=this.thresholds.lg-this.scrollBarWidth;switch(this.height=e,this.width=n,this.xs=r,this.sm=i,this.md=o,this.lg=a,this.xl=s,this.xsOnly=r,this.smOnly=i,this.smAndDown=(r||i)&&!(o||a||s),this.smAndUp=!r&&(i||o||a||s),this.mdOnly=o,this.mdAndDown=(r||i||o)&&!(a||s),this.mdAndUp=!(r||i)&&(o||a||s),this.lgOnly=a,this.lgAndDown=(r||i||o||a)&&!s,this.lgAndUp=!(r||i||o)&&(a||s),this.xlOnly=s,!0){case r:this.name="xs";break;case i:this.name="sm";break;case o:this.name="md";break;case a:this.name="lg";break;default:this.name="xl";break}if("number"!==typeof this.mobileBreakpoint){var c={xs:0,sm:1,md:2,lg:3,xl:4},u=c[this.name],l=c[this.mobileBreakpoint];this.mobile=u<=l}else this.mobile=n1&&void 0!==arguments[1]?arguments[1]:{},n=Object(E["a"])({container:document.scrollingElement||document.body||document.documentElement,duration:500,offset:0,easing:"easeInOutCubic",appOffset:!0},e),i=U(n.container);if(n.appOffset&&Z.framework.application){var o=i.classList.contains("v-navigation-drawer"),a=i.classList.contains("v-navigation-drawer--clipped"),s=Z.framework.application,c=s.bar,u=s.top;n.offset+=c,o&&!a||(n.offset+=u)}var l,f=performance.now();l="number"===typeof t?V(t)-n.offset:V(t)-V(i)-n.offset;var d=i.scrollTop;if(l===d)return Promise.resolve(l);var p="function"===typeof n.easing?n.easing:r[n.easing];if(!p)throw new TypeError('Easing function "'.concat(n.easing,'" not found.'));return new Promise((function(t){return requestAnimationFrame((function e(r){var o=r-f,a=Math.abs(n.duration?Math.min(o/n.duration,1):1);i.scrollTop=Math.floor(d+(l-d)*p(a));var s=i===document.body?document.documentElement.clientHeight:i.clientHeight;if(1===a||s+i.scrollTop===i.scrollHeight)return t(l);requestAnimationFrame(e)}))}))}Z.framework={},Z.init=function(){};var G=function(t){p(n,t);var e=x(n);function n(){var t;return i(this,n),t=e.call(this),y(t,Z)}return n}(O);G.property="goTo";n("ddb0"),n("dca8");var K={complete:"M21,7L9,19L3.5,13.5L4.91,12.09L9,16.17L19.59,5.59L21,7Z",cancel:"M12,2C17.53,2 22,6.47 22,12C22,17.53 17.53,22 12,22C6.47,22 2,17.53 2,12C2,6.47 6.47,2 12,2M15.59,7L12,10.59L8.41,7L7,8.41L10.59,12L7,15.59L8.41,17L12,13.41L15.59,17L17,15.59L13.41,12L17,8.41L15.59,7Z",close:"M19,6.41L17.59,5L12,10.59L6.41,5L5,6.41L10.59,12L5,17.59L6.41,19L12,13.41L17.59,19L19,17.59L13.41,12L19,6.41Z",delete:"M12,2C17.53,2 22,6.47 22,12C22,17.53 17.53,22 12,22C6.47,22 2,17.53 2,12C2,6.47 6.47,2 12,2M15.59,7L12,10.59L8.41,7L7,8.41L10.59,12L7,15.59L8.41,17L12,13.41L15.59,17L17,15.59L13.41,12L17,8.41L15.59,7Z",clear:"M19,6.41L17.59,5L12,10.59L6.41,5L5,6.41L10.59,12L5,17.59L6.41,19L12,13.41L17.59,19L19,17.59L13.41,12L19,6.41Z",success:"M12,2C17.52,2 22,6.48 22,12C22,17.52 17.52,22 12,22C6.48,22 2,17.52 2,12C2,6.48 6.48,2 12,2M11,16.5L18,9.5L16.59,8.09L11,13.67L7.91,10.59L6.5,12L11,16.5Z",info:"M13,9H11V7H13M13,17H11V11H13M12,2C6.48,2 2,6.48 2,12C2,17.52 6.48,22 12,22C17.52,22 22,17.52 22,12C22,6.48 17.52,2 12,2Z",warning:"M11,4.5H13V15.5H11V4.5M13,17.5V19.5H11V17.5H13Z",error:"M13,14H11V10H13M13,18H11V16H13M1,21H23L12,2L1,21Z",prev:"M15.41,16.58L10.83,12L15.41,7.41L14,6L8,12L14,18L15.41,16.58Z",next:"M8.59,16.58L13.17,12L8.59,7.41L10,6L16,12L10,18L8.59,16.58Z",checkboxOn:"M10,17L5,12L6.41,10.58L10,14.17L17.59,6.58L19,8M19,3H5C3.89,3 3,3.89 3,5V19C3,20.1 3.9,21 5,21H19C20.1,21 21,20.1 21,19V5C21,3.89 20.1,3 19,3Z",checkboxOff:"M19,3H5C3.89,3 3,3.89 3,5V19C3,20.1 3.9,21 5,21H19C20.1,21 21,20.1 21,19V5C21,3.89 20.1,3 19,3M19,5V19H5V5H19Z",checkboxIndeterminate:"M17,13H7V11H17M19,3H5C3.89,3 3,3.89 3,5V19C3,20.1 3.9,21 5,21H19C20.1,21 21,20.1 21,19V5C21,3.89 20.1,3 19,3Z",delimiter:"M12,2C6.48,2 2,6.48 2,12C2,17.52 6.48,22 12,22C17.52,22 22,17.52 22,12C22,6.48 17.52,2 12,2Z",sort:"M13,20H11V8L5.5,13.5L4.08,12.08L12,4.16L19.92,12.08L18.5,13.5L13,8V20Z",expand:"M7.41,8.58L12,13.17L16.59,8.58L18,10L12,16L6,10L7.41,8.58Z",menu:"M3,6H21V8H3V6M3,11H21V13H3V11M3,16H21V18H3V16Z",subgroup:"M7,10L12,15L17,10H7Z",dropdown:"M7,10L12,15L17,10H7Z",radioOn:"M12,20C7.58,20 4,16.42 4,12C4,7.58 7.58,4 12,4C16.42,4 20,7.58 20,12C20,16.42 16.42,20 12,20M12,2C6.48,2 2,6.48 2,12C2,17.52 6.48,22 12,22C17.52,22 22,17.52 22,12C22,6.48 17.52,2 12,2M12,7C9.24,7 7,9.24 7,12C7,14.76 9.24,17 12,17C14.76,17 17,14.76 17,12C17,9.24 14.76,7 12,7Z",radioOff:"M12,20C7.58,20 4,16.42 4,12C4,7.58 7.58,4 12,4C16.42,4 20,7.58 20,12C20,16.42 16.42,20 12,20M12,2C6.48,2 2,6.48 2,12C2,17.52 6.48,22 12,22C17.52,22 22,17.52 22,12C22,6.48 17.52,2 12,2Z",edit:"M20.71,7.04C21.1,6.65 21.1,6 20.71,5.63L18.37,3.29C18,2.9 17.35,2.9 16.96,3.29L15.12,5.12L18.87,8.87M3,17.25V21H6.75L17.81,9.93L14.06,6.18L3,17.25Z",ratingEmpty:"M12,15.39L8.24,17.66L9.23,13.38L5.91,10.5L10.29,10.13L12,6.09L13.71,10.13L18.09,10.5L14.77,13.38L15.76,17.66M22,9.24L14.81,8.63L12,2L9.19,8.63L2,9.24L7.45,13.97L5.82,21L12,17.27L18.18,21L16.54,13.97L22,9.24Z",ratingFull:"M12,17.27L18.18,21L16.54,13.97L22,9.24L14.81,8.62L12,2L9.19,8.62L2,9.24L7.45,13.97L5.82,21L12,17.27Z",ratingHalf:"M12,15.4V6.1L13.71,10.13L18.09,10.5L14.77,13.39L15.76,17.67M22,9.24L14.81,8.63L12,2L9.19,8.63L2,9.24L7.45,13.97L5.82,21L12,17.27L18.18,21L16.54,13.97L22,9.24Z",loading:"M19,8L15,12H18C18,15.31 15.31,18 12,18C11,18 10.03,17.75 9.2,17.3L7.74,18.76C8.97,19.54 10.43,20 12,20C16.42,20 20,16.42 20,12H23M6,12C6,8.69 8.69,6 12,6C13,6 13.97,6.25 14.8,6.7L16.26,5.24C15.03,4.46 13.57,4 12,4C7.58,4 4,7.58 4,12H1L5,16L9,12",first:"M18.41,16.59L13.82,12L18.41,7.41L17,6L11,12L17,18L18.41,16.59M6,6H8V18H6V6Z",last:"M5.59,7.41L10.18,12L5.59,16.59L7,18L13,12L7,6L5.59,7.41M16,6H18V18H16V6Z",unfold:"M12,18.17L8.83,15L7.42,16.41L12,21L16.59,16.41L15.17,15M12,5.83L15.17,9L16.58,7.59L12,3L7.41,7.59L8.83,9L12,5.83Z",file:"M16.5,6V17.5C16.5,19.71 14.71,21.5 12.5,21.5C10.29,21.5 8.5,19.71 8.5,17.5V5C8.5,3.62 9.62,2.5 11,2.5C12.38,2.5 13.5,3.62 13.5,5V15.5C13.5,16.05 13.05,16.5 12.5,16.5C11.95,16.5 11.5,16.05 11.5,15.5V6H10V15.5C10,16.88 11.12,18 12.5,18C13.88,18 15,16.88 15,15.5V5C15,2.79 13.21,1 11,1C8.79,1 7,2.79 7,5V17.5C7,20.54 9.46,23 12.5,23C15.54,23 18,20.54 18,17.5V6H16.5Z",plus:"M19,13H13V19H11V13H5V11H11V5H13V11H19V13Z",minus:"M19,13H5V11H19V13Z"},X=K,Y={complete:"check",cancel:"cancel",close:"close",delete:"cancel",clear:"clear",success:"check_circle",info:"info",warning:"priority_high",error:"warning",prev:"chevron_left",next:"chevron_right",checkboxOn:"check_box",checkboxOff:"check_box_outline_blank",checkboxIndeterminate:"indeterminate_check_box",delimiter:"fiber_manual_record",sort:"arrow_upward",expand:"keyboard_arrow_down",menu:"menu",subgroup:"arrow_drop_down",dropdown:"arrow_drop_down",radioOn:"radio_button_checked",radioOff:"radio_button_unchecked",edit:"edit",ratingEmpty:"star_border",ratingFull:"star",ratingHalf:"star_half",loading:"cached",first:"first_page",last:"last_page",unfold:"unfold_more",file:"attach_file",plus:"add",minus:"remove"},Q=Y,J={complete:"mdi-check",cancel:"mdi-close-circle",close:"mdi-close",delete:"mdi-close-circle",clear:"mdi-close",success:"mdi-check-circle",info:"mdi-information",warning:"mdi-exclamation",error:"mdi-alert",prev:"mdi-chevron-left",next:"mdi-chevron-right",checkboxOn:"mdi-checkbox-marked",checkboxOff:"mdi-checkbox-blank-outline",checkboxIndeterminate:"mdi-minus-box",delimiter:"mdi-circle",sort:"mdi-arrow-up",expand:"mdi-chevron-down",menu:"mdi-menu",subgroup:"mdi-menu-down",dropdown:"mdi-menu-down",radioOn:"mdi-radiobox-marked",radioOff:"mdi-radiobox-blank",edit:"mdi-pencil",ratingEmpty:"mdi-star-outline",ratingFull:"mdi-star",ratingHalf:"mdi-star-half-full",loading:"mdi-cached",first:"mdi-page-first",last:"mdi-page-last",unfold:"mdi-unfold-more-horizontal",file:"mdi-paperclip",plus:"mdi-plus",minus:"mdi-minus"},tt=J,et={complete:"fas fa-check",cancel:"fas fa-times-circle",close:"fas fa-times",delete:"fas fa-times-circle",clear:"fas fa-times-circle",success:"fas fa-check-circle",info:"fas fa-info-circle",warning:"fas fa-exclamation",error:"fas fa-exclamation-triangle",prev:"fas fa-chevron-left",next:"fas fa-chevron-right",checkboxOn:"fas fa-check-square",checkboxOff:"far fa-square",checkboxIndeterminate:"fas fa-minus-square",delimiter:"fas fa-circle",sort:"fas fa-sort-up",expand:"fas fa-chevron-down",menu:"fas fa-bars",subgroup:"fas fa-caret-down",dropdown:"fas fa-caret-down",radioOn:"far fa-dot-circle",radioOff:"far fa-circle",edit:"fas fa-edit",ratingEmpty:"far fa-star",ratingFull:"fas fa-star",ratingHalf:"fas fa-star-half",loading:"fas fa-sync",first:"fas fa-step-backward",last:"fas fa-step-forward",unfold:"fas fa-arrows-alt-v",file:"fas fa-paperclip",plus:"fas fa-plus",minus:"fas fa-minus"},nt=et,rt={complete:"fa fa-check",cancel:"fa fa-times-circle",close:"fa fa-times",delete:"fa fa-times-circle",clear:"fa fa-times-circle",success:"fa fa-check-circle",info:"fa fa-info-circle",warning:"fa fa-exclamation",error:"fa fa-exclamation-triangle",prev:"fa fa-chevron-left",next:"fa fa-chevron-right",checkboxOn:"fa fa-check-square",checkboxOff:"fa fa-square-o",checkboxIndeterminate:"fa fa-minus-square",delimiter:"fa fa-circle",sort:"fa fa-sort-up",expand:"fa fa-chevron-down",menu:"fa fa-bars",subgroup:"fa fa-caret-down",dropdown:"fa fa-caret-down",radioOn:"fa fa-dot-circle-o",radioOff:"fa fa-circle-o",edit:"fa fa-pencil",ratingEmpty:"fa fa-star-o",ratingFull:"fa fa-star",ratingHalf:"fa fa-star-half-o",loading:"fa fa-refresh",first:"fa fa-step-backward",last:"fa fa-step-forward",unfold:"fa fa-angle-double-down",file:"fa fa-paperclip",plus:"fa fa-plus",minus:"fa fa-minus"},it=rt;n("ac1f"),n("1276");function ot(t,e){var n={};for(var r in e)n[r]={component:t,props:{icon:e[r].split(" fa-")}};return n}var at=ot("font-awesome-icon",nt),st=Object.freeze({mdiSvg:X,md:Q,mdi:tt,fa:nt,fa4:it,faSvg:at}),ct=function(t){p(n,t);var e=x(n);function n(t){var r;i(this,n),r=e.call(this);var o=t[n.property],a=o.iconfont,s=o.values,c=o.component;return r.component=c,r.iconfont=a,r.values=Object(S["l"])(st[a],s),r}return n}(O);ct.property="icons";n("e01a"),n("5319"),n("2ca0"),n("99af");var ut="$vuetify.",lt=Symbol("Lang fallback");function ft(t,e){var n=arguments.length>2&&void 0!==arguments[2]&&arguments[2],r=arguments.length>3?arguments[3]:void 0,i=e.replace(ut,""),o=Object(S["h"])(t,i,lt);return o===lt&&(n?(Object(c["b"])('Translation key "'.concat(i,'" not found in fallback')),o=e):(Object(c["c"])('Translation key "'.concat(i,'" not found, falling back to default')),o=ft(r,e,!0,r))),o}var dt=function(t){p(n,t);var e=x(n);function n(t){var r;i(this,n),r=e.call(this),r.defaultLocale="en";var o=t[n.property],a=o.current,s=o.locales,c=o.t;return r.current=a,r.locales=s,r.translator=c||r.defaultTranslator,r}return a(n,[{key:"currentLocale",value:function(t){var e=this.locales[this.current],n=this.locales[this.defaultLocale];return ft(e,t,!1,n)}},{key:"t",value:function(t){for(var e=arguments.length,n=new Array(e>1?e-1:0),r=1;r1?e-1:0),r=1;rMath.pow(gt,3)?Math.cbrt(t):t/(3*Math.pow(gt,2))+4/29},yt=function(t){return t>gt?Math.pow(t,3):3*Math.pow(gt,2)*(t-4/29)};function xt(t){var e=bt,n=e(t[1]);return[116*n-16,500*(e(t[0]/.95047)-n),200*(n-e(t[2]/1.08883))]}function wt(t){var e=yt,n=(t[0]+16)/116;return[.95047*e(n+t[1]/500),e(n),1.08883*e(n-t[2]/200)]}function _t(t){for(var e=arguments.length>1&&void 0!==arguments[1]&&arguments[1],n=!(arguments.length>2&&void 0!==arguments[2])||arguments[2],r=t.anchor,i=f(t,["anchor"]),o=Object.keys(i),a={},s=0;s1&&void 0!==arguments[1]?arguments[1]:"base";return"--v-".concat(t,"-").concat(e)},kt=function(t){var e=arguments.length>1&&void 0!==arguments[1]?arguments[1]:"base";return"var(".concat(Ct(t,e),")")};function jt(t){var e=arguments.length>1&&void 0!==arguments[1]&&arguments[1],n=t.anchor,r=f(t,["anchor"]),i=Object.keys(r);if(!i.length)return"";var o="",a="",s=e?kt("anchor"):n;a+=".v-application a { color: ".concat(s,"; }"),e&&(o+=" ".concat(Ct("anchor"),": ").concat(n,";\n"));for(var c=0;c0;--r)n["lighten".concat(r)]=Object(vt["c"])(Et(e,r));for(var i=1;i<=4;++i)n["darken".concat(i)]=Object(vt["c"])(At(e,i));return n}function Et(t,e){var n=xt(mt["b"](t));return n[0]=n[0]+10*e,mt["a"](wt(n))}function At(t,e){var n=xt(mt["b"](t));return n[0]=n[0]-10*e,mt["a"](wt(n))}var $t=function(t){p(n,t);var e=x(n);function n(t){var r;i(this,n),r=e.call(this),r.disabled=!1,r.isDark=null,r.unwatch=null,r.vueMeta=null;var o=t[n.property],a=o.dark,s=o.disable,c=o.options,u=o.themes;return r.dark=Boolean(a),r.defaults=r.themes=u,r.options=c,s?(r.disabled=!0,y(r)):(r.themes={dark:r.fillVariant(u.dark,!0),light:r.fillVariant(u.light,!1)},r)}return a(n,[{key:"css",set:function(t){this.vueMeta?this.isVueMeta23&&this.applyVueMeta23():this.checkOrCreateStyleElement()&&(this.styleEl.innerHTML=t)}},{key:"dark",get:function(){return Boolean(this.isDark)},set:function(t){var e=this.isDark;this.isDark=t,null!=e&&this.applyTheme()}},{key:"applyTheme",value:function(){if(this.disabled)return this.clearCss();this.css=this.generatedStyles}},{key:"clearCss",value:function(){this.css=""}},{key:"init",value:function(t,e){this.disabled||(t.$meta?this.initVueMeta(t):e&&this.initSSR(e),this.initTheme(t))}},{key:"setTheme",value:function(t,e){this.themes[t]=Object.assign(this.themes[t],e),this.applyTheme()}},{key:"resetThemes",value:function(){this.themes.light=Object.assign({},this.defaults.light),this.themes.dark=Object.assign({},this.defaults.dark),this.applyTheme()}},{key:"checkOrCreateStyleElement",value:function(){return this.styleEl=document.getElementById("vuetify-theme-stylesheet"),!!this.styleEl||(this.genStyleElement(),Boolean(this.styleEl))}},{key:"fillVariant",value:function(){var t=arguments.length>0&&void 0!==arguments[0]?arguments[0]:{},e=arguments.length>1?arguments[1]:void 0,n=this.themes[e?"dark":"light"];return Object.assign({},n,t)}},{key:"genStyleElement",value:function(){"undefined"!==typeof document&&(this.styleEl=document.createElement("style"),this.styleEl.type="text/css",this.styleEl.id="vuetify-theme-stylesheet",this.options.cspNonce&&this.styleEl.setAttribute("nonce",this.options.cspNonce),document.head.appendChild(this.styleEl))}},{key:"initVueMeta",value:function(t){var e=this;if(this.vueMeta=t.$meta(),this.isVueMeta23)t.$nextTick((function(){e.applyVueMeta23()}));else{var n="function"===typeof this.vueMeta.getOptions?this.vueMeta.getOptions().keyName:"metaInfo",r=t.$options[n]||{};t.$options[n]=function(){r.style=r.style||[];var t=r.style.find((function(t){return"vuetify-theme-stylesheet"===t.id}));return t?t.cssText=e.generatedStyles:r.style.push({cssText:e.generatedStyles,type:"text/css",id:"vuetify-theme-stylesheet",nonce:(e.options||{}).cspNonce}),r}}}},{key:"applyVueMeta23",value:function(){var t=this.vueMeta.addApp("vuetify"),e=t.set;e({style:[{cssText:this.generatedStyles,type:"text/css",id:"vuetify-theme-stylesheet",nonce:this.options.cspNonce}]})}},{key:"initSSR",value:function(t){var e=this.options.cspNonce?' nonce="'.concat(this.options.cspNonce,'"'):"";t.head=t.head||"",t.head+='")}},{key:"initTheme",value:function(t){var e=this;"undefined"!==typeof document&&(this.unwatch&&(this.unwatch(),this.unwatch=null),t.$once("hook:created",(function(){var n=s["a"].observable({themes:e.themes});e.unwatch=t.$watch((function(){return n.themes}),(function(){return e.applyTheme()}),{deep:!0})})),this.applyTheme())}},{key:"currentTheme",get:function(){var t=this.dark?"dark":"light";return this.themes[t]}},{key:"generatedStyles",get:function(){var t,e=this.parsedTheme,n=this.options||{};return null!=n.themeCache&&(t=n.themeCache.get(e),null!=t)||(t=jt(e,n.customProperties),null!=n.minifyTheme&&(t=n.minifyTheme(t)),null!=n.themeCache&&n.themeCache.set(e,t)),t}},{key:"parsedTheme",get:function(){return _t(this.currentTheme||{},void 0,Object(S["g"])(this.options,["variations"],!0))}},{key:"isVueMeta23",get:function(){return"function"===typeof this.vueMeta.addApp}}]),n}(O);$t.property="theme";var Tt=function(){function t(){var e=arguments.length>0&&void 0!==arguments[0]?arguments[0]:{};i(this,t),this.framework={isHydrating:!1},this.installed=[],this.preset={},this.userPreset={},this.userPreset=e,this.use(C),this.use(j),this.use(L),this.use(G),this.use(ct),this.use(dt),this.use($t)}return a(t,[{key:"init",value:function(t,e){var n=this;this.installed.forEach((function(r){var i=n.framework[r];i.framework=n.framework,i.init(t,e)})),this.framework.rtl=Boolean(this.preset.rtl)}},{key:"use",value:function(t){var e=t.property;this.installed.includes(e)||(this.framework[e]=new t(this.preset,this),this.installed.push(e))}}]),t}();Tt.install=u,Tt.installed=!1,Tt.version="2.5.0",Tt.config={silent:!1}},f5df:function(t,e,n){var r=n("00ee"),i=n("c6b6"),o=n("b622"),a=o("toStringTag"),s="Arguments"==i(function(){return arguments}()),c=function(t,e){try{return t[e]}catch(n){}};t.exports=r?i:function(t){var e,n,r;return void 0===t?"Undefined":null===t?"Null":"string"==typeof(n=c(e=Object(t),a))?n:s?i(e):"Object"==(r=i(e))&&"function"==typeof e.callee?"Arguments":r}},f6b4:function(t,e,n){"use strict";var r=n("c532");function i(){this.handlers=[]}i.prototype.use=function(t,e){return this.handlers.push({fulfilled:t,rejected:e}),this.handlers.length-1},i.prototype.eject=function(t){this.handlers[t]&&(this.handlers[t]=null)},i.prototype.forEach=function(t){r.forEach(this.handlers,(function(e){null!==e&&t(e)}))},t.exports=i},f6c4:function(t,e,n){"use strict";n("bd0c");var r=n("d10f");e["a"]=r["a"].extend({name:"v-main",props:{tag:{type:String,default:"main"}},computed:{styles:function(){var t=this.$vuetify.application,e=t.bar,n=t.top,r=t.right,i=t.footer,o=t.insetFooter,a=t.bottom,s=t.left;return{paddingTop:"".concat(n+e,"px"),paddingRight:"".concat(r,"px"),paddingBottom:"".concat(i+o+a,"px"),paddingLeft:"".concat(s,"px")}}},render:function(t){var e={staticClass:"v-main",style:this.styles,ref:"main"};return t(this.tag,e,[t("div",{staticClass:"v-main__wrap"},this.$slots.default)])}})},f748:function(t,e){t.exports=Math.sign||function(t){return 0==(t=+t)||t!=t?t:t<0?-1:1}},f772:function(t,e,n){var r=n("5692"),i=n("90e3"),o=r("keys");t.exports=function(t){return o[t]||(o[t]=i(t))}},fb6a:function(t,e,n){"use strict";var r=n("23e7"),i=n("861d"),o=n("e8b5"),a=n("23cb"),s=n("50c4"),c=n("fc6a"),u=n("8418"),l=n("b622"),f=n("1dde"),d=f("slice"),p=l("species"),h=[].slice,v=Math.max;r({target:"Array",proto:!0,forced:!d},{slice:function(t,e){var n,r,l,f=c(this),d=s(f.length),m=a(t,d),g=a(void 0===e?d:e,d);if(o(f)&&(n=f.constructor,"function"!=typeof n||n!==Array&&!o(n.prototype)?i(n)&&(n=n[p],null===n&&(n=void 0)):n=void 0,n===Array||void 0===n))return h.call(f,m,g);for(r=new(void 0===n?Array:n)(v(g-m,0)),l=0;m0&&void 0!==arguments[0]?arguments[0]:[];return r["a"].extend({name:"positionable",props:t.length?Object(i["f"])(o,t):o})}e["a"]=a()},fea9:function(t,e,n){var r=n("da84");t.exports=r.Promise}}]); -//# sourceMappingURL=chunk-vendors.84a48fc6.js.map \ No newline at end of file diff --git a/frontend/dist/static/js/chunk-vendors.84a48fc6.js.map b/frontend/dist/static/js/chunk-vendors.84a48fc6.js.map deleted file mode 100644 index fecca46..0000000 --- a/frontend/dist/static/js/chunk-vendors.84a48fc6.js.map +++ /dev/null @@ -1 +0,0 @@ -{"version":3,"sources":["webpack:///./node_modules/core-js/internals/to-string-tag-support.js","webpack:///./node_modules/core-js/internals/function-bind-context.js","webpack:///./node_modules/core-js/modules/es.array.flat.js","webpack:///./node_modules/core-js/internals/function-bind.js","webpack:///./node_modules/core-js/internals/object-get-own-property-names-external.js","webpack:///./node_modules/@babel/runtime/helpers/esm/arrayLikeToArray.js","webpack:///./node_modules/@babel/runtime/helpers/esm/unsupportedIterableToArray.js","webpack:///./node_modules/core-js/internals/object-get-own-property-descriptor.js","webpack:///./node_modules/core-js/modules/es.object.values.js","webpack:///./node_modules/axios/lib/core/Axios.js","webpack:///./node_modules/core-js/internals/get-substitution.js","webpack:///./node_modules/core-js/internals/ie8-dom-define.js","webpack:///./node_modules/axios/lib/helpers/spread.js","webpack:///../../../src/components/VGrid/VRow.ts","webpack:///./node_modules/core-js/internals/string-repeat.js","webpack:///./node_modules/core-js/modules/es.string.split.js","webpack:///../../../src/components/VIcon/VIcon.ts","webpack:///./node_modules/core-js/internals/regexp-exec-abstract.js","webpack:///./node_modules/core-js/modules/web.dom-collections.for-each.js","webpack:///./node_modules/core-js/internals/array-for-each.js","webpack:///./node_modules/core-js/modules/es.string.anchor.js","webpack:///./node_modules/core-js/internals/an-instance.js","webpack:///./node_modules/core-js/internals/html.js","webpack:///./node_modules/core-js/internals/a-function.js","webpack:///./node_modules/core-js/internals/check-correctness-of-iteration.js","webpack:///./node_modules/core-js/internals/engine-is-ios.js","webpack:///./node_modules/axios/lib/helpers/bind.js","webpack:///./node_modules/core-js/internals/require-object-coercible.js","webpack:///./node_modules/core-js/internals/array-method-has-species-support.js","webpack:///./node_modules/core-js/internals/iterate.js","webpack:///./node_modules/core-js/internals/to-absolute-index.js","webpack:///./node_modules/core-js/internals/export.js","webpack:///./node_modules/core-js/internals/object-get-own-property-names.js","webpack:///./node_modules/axios/lib/defaults.js","webpack:///../../../src/mixins/measurable/index.ts","webpack:///./node_modules/core-js/modules/es.string.includes.js","webpack:///./node_modules/core-js/modules/es.regexp.to-string.js","webpack:///./node_modules/core-js/internals/set-species.js","webpack:///./node_modules/vue-loader/lib/runtime/componentNormalizer.js","webpack:///./node_modules/core-js/internals/iterator-close.js","webpack:///./node_modules/vue/dist/vue.runtime.esm.js","webpack:///./node_modules/core-js/modules/es.string.starts-with.js","webpack:///./node_modules/core-js/internals/task.js","webpack:///./node_modules/core-js/internals/engine-v8-version.js","webpack:///./node_modules/axios/lib/core/createError.js","webpack:///./node_modules/axios/lib/cancel/isCancel.js","webpack:///../../../src/components/VGrid/VSpacer.ts","webpack:///./node_modules/axios/lib/helpers/buildURL.js","webpack:///./node_modules/core-js/modules/es.object.get-prototype-of.js","webpack:///./node_modules/core-js/internals/engine-user-agent.js","webpack:///./node_modules/core-js/internals/get-iterator-method.js","webpack:///./node_modules/core-js/internals/object-define-properties.js","webpack:///./node_modules/@babel/runtime/helpers/esm/arrayWithHoles.js","webpack:///./node_modules/@babel/runtime/helpers/esm/iterableToArrayLimit.js","webpack:///./node_modules/@babel/runtime/helpers/esm/nonIterableRest.js","webpack:///./node_modules/@babel/runtime/helpers/esm/slicedToArray.js","webpack:///./node_modules/axios/lib/core/enhanceError.js","webpack:///./node_modules/core-js/modules/es.string.repeat.js","webpack:///./node_modules/axios/lib/helpers/isURLSameOrigin.js","webpack:///./node_modules/core-js/internals/a-possible-prototype.js","webpack:///./node_modules/core-js/modules/es.string.iterator.js","webpack:///./node_modules/core-js/modules/es.math.cbrt.js","webpack:///./node_modules/core-js/internals/iterators.js","webpack:///./node_modules/core-js/internals/this-number-value.js","webpack:///../../../src/components/VToolbar/VToolbar.ts","webpack:///../../../src/directives/scroll/index.ts","webpack:///../../../src/mixins/applicationable/index.ts","webpack:///../../../src/mixins/scrollable/index.ts","webpack:///../../../src/components/VAppBar/VAppBar.ts","webpack:///./node_modules/core-js/internals/path.js","webpack:///./node_modules/core-js/internals/indexed-object.js","webpack:///./node_modules/core-js/internals/add-to-unscopables.js","webpack:///./node_modules/core-js/internals/host-report-errors.js","webpack:///./node_modules/core-js/internals/is-regexp.js","webpack:///./node_modules/core-js/modules/es.string.match.js","webpack:///./node_modules/axios/lib/core/settle.js","webpack:///./node_modules/core-js/internals/species-constructor.js","webpack:///./node_modules/core-js/internals/native-symbol.js","webpack:///./node_modules/core-js/modules/es.string.trim.js","webpack:///./node_modules/core-js/modules/es.reflect.construct.js","webpack:///./node_modules/core-js/internals/array-includes.js","webpack:///./node_modules/core-js/modules/es.array.filter.js","webpack:///./node_modules/core-js/internals/array-from.js","webpack:///./node_modules/core-js/modules/es.map.js","webpack:///./node_modules/core-js/internals/to-length.js","webpack:///./node_modules/core-js/internals/has.js","webpack:///./node_modules/axios/lib/core/dispatchRequest.js","webpack:///./node_modules/core-js/modules/es.string.replace.js","webpack:///./node_modules/@babel/runtime/helpers/esm/typeof.js","webpack:///./node_modules/@babel/runtime/helpers/esm/objectSpread2.js","webpack:///./node_modules/core-js/internals/shared.js","webpack:///./node_modules/core-js/internals/own-keys.js","webpack:///./node_modules/core-js/internals/whitespaces.js","webpack:///./node_modules/core-js/internals/string-trim.js","webpack:///../../src/util/mixins.ts","webpack:///./node_modules/core-js/internals/not-a-regexp.js","webpack:///./node_modules/core-js/internals/create-property-descriptor.js","webpack:///./node_modules/core-js/internals/engine-is-node.js","webpack:///./node_modules/core-js/internals/engine-is-browser.js","webpack:///./node_modules/core-js/internals/object-assign.js","webpack:///../../../src/components/VGrid/VCol.ts","webpack:///./node_modules/vuetify-loader/lib/runtime/installComponents.js","webpack:///./node_modules/core-js/internals/string-multibyte.js","webpack:///./node_modules/core-js/internals/collection-strong.js","webpack:///./node_modules/core-js/internals/array-species-create.js","webpack:///./node_modules/core-js/internals/internal-state.js","webpack:///./node_modules/core-js/internals/collection.js","webpack:///./node_modules/core-js/internals/redefine.js","webpack:///./node_modules/core-js/internals/object-to-array.js","webpack:///./node_modules/@babel/runtime/helpers/typeof.js","webpack:///./node_modules/core-js/internals/inherit-if-required.js","webpack:///./node_modules/core-js/internals/object-get-own-property-symbols.js","webpack:///./node_modules/core-js/internals/define-well-known-symbol.js","webpack:///../../../src/components/VApp/VApp.ts","webpack:///../../../src/mixins/themeable/index.ts","webpack:///./node_modules/core-js/internals/enum-bug-keys.js","webpack:///./node_modules/axios/lib/cancel/Cancel.js","webpack:///./node_modules/axios/lib/helpers/cookies.js","webpack:///./node_modules/core-js/internals/to-object.js","webpack:///../../src/util/colorUtils.ts","webpack:///./node_modules/core-js/internals/object-create.js","webpack:///./node_modules/core-js/modules/es.array.find.js","webpack:///./node_modules/core-js/internals/define-iterator.js","webpack:///../../../src/mixins/binds-attrs/index.ts","webpack:///./node_modules/core-js/internals/native-weak-map.js","webpack:///../../src/util/helpers.ts","webpack:///./node_modules/core-js/internals/array-fill.js","webpack:///./node_modules/core-js/internals/an-object.js","webpack:///../../../src/components/VSheet/index.ts","webpack:///../../../src/components/VProgressCircular/VProgressCircular.ts","webpack:///../../../src/components/VProgressCircular/index.ts","webpack:///../../../src/mixins/registrable/index.ts","webpack:///../../../src/mixins/groupable/index.ts","webpack:///../../../src/directives/ripple/index.ts","webpack:///../../../src/mixins/routable/index.ts","webpack:///../../../src/components/VBtn/VBtn.ts","webpack:///./node_modules/core-js/internals/descriptors.js","webpack:///./node_modules/core-js/internals/create-property.js","webpack:///./node_modules/core-js/internals/create-html.js","webpack:///./node_modules/core-js/internals/is-object.js","webpack:///./node_modules/core-js/internals/inspect-source.js","webpack:///./node_modules/core-js/modules/es.string.ends-with.js","webpack:///./node_modules/core-js/internals/advance-string-index.js","webpack:///../../../src/util/color/transformSRGB.ts","webpack:///../../../src/mixins/roundable/index.ts","webpack:///../../../src/components/VSheet/VSheet.ts","webpack:///./node_modules/axios/lib/cancel/CancelToken.js","webpack:///../../../src/directives/intersect/index.ts","webpack:///./node_modules/core-js/internals/uid.js","webpack:///./node_modules/core-js/internals/create-non-enumerable-property.js","webpack:///./node_modules/core-js/internals/regexp-exec.js","webpack:///./node_modules/core-js/internals/is-forced.js","webpack:///./node_modules/core-js/modules/es.string.link.js","webpack:///./node_modules/core-js/modules/es.array.concat.js","webpack:///./node_modules/core-js/internals/call-with-safe-iteration-closing.js","webpack:///./node_modules/core-js/internals/object-define-property.js","webpack:///./node_modules/core-js/internals/create-iterator-constructor.js","webpack:///./node_modules/core-js/internals/regexp-sticky-helpers.js","webpack:///./node_modules/core-js/modules/es.array.join.js","webpack:///./node_modules/core-js/internals/flatten-into-array.js","webpack:///./node_modules/core-js/internals/engine-is-webos-webkit.js","webpack:///./node_modules/core-js/modules/es.symbol.js","webpack:///../../../src/components/VGrid/grid.ts","webpack:///../../../src/components/VGrid/VContainer.ts","webpack:///./node_modules/core-js/modules/es.array.from.js","webpack:///./node_modules/core-js/internals/array-method-is-strict.js","webpack:///./node_modules/core-js/internals/to-integer.js","webpack:///./node_modules/core-js/modules/es.promise.finally.js","webpack:///../../../src/mixins/colorable/index.ts","webpack:///./node_modules/core-js/modules/es.number.constructor.js","webpack:///./node_modules/core-js/internals/correct-is-regexp-logic.js","webpack:///./node_modules/core-js/modules/es.regexp.exec.js","webpack:///./node_modules/core-js/internals/regexp-flags.js","webpack:///../../../src/components/VResponsive/VResponsive.ts","webpack:///../../../src/components/VResponsive/index.ts","webpack:///../../../src/components/VImg/VImg.ts","webpack:///./node_modules/@babel/runtime/helpers/esm/defineProperty.js","webpack:///./node_modules/core-js/internals/iterators-core.js","webpack:///./node_modules/core-js/internals/string-html-forced.js","webpack:///../../../src/mixins/sizeable/index.ts","webpack:///./node_modules/core-js/internals/object-to-string.js","webpack:///./node_modules/core-js/modules/es.function.name.js","webpack:///./node_modules/axios/lib/adapters/xhr.js","webpack:///./node_modules/core-js/internals/microtask.js","webpack:///./node_modules/core-js/internals/well-known-symbol.js","webpack:///./node_modules/core-js/modules/es.object.keys.js","webpack:///./node_modules/core-js/modules/es.number.to-fixed.js","webpack:///./node_modules/core-js/internals/array-iteration.js","webpack:///./node_modules/@babel/runtime/helpers/esm/createForOfIteratorHelper.js","webpack:///./node_modules/core-js/internals/freezing.js","webpack:///./node_modules/axios/index.js","webpack:///./node_modules/core-js/internals/to-primitive.js","webpack:///./node_modules/axios/lib/helpers/parseHeaders.js","webpack:///./node_modules/axios/lib/core/transformData.js","webpack:///./node_modules/core-js/internals/is-pure.js","webpack:///./node_modules/axios/lib/utils.js","webpack:///./node_modules/core-js/internals/classof-raw.js","webpack:///./node_modules/core-js/internals/shared-store.js","webpack:///./node_modules/core-js/modules/es.string.fixed.js","webpack:///./node_modules/axios/node_modules/is-buffer/index.js","webpack:///./node_modules/axios/lib/helpers/normalizeHeaderName.js","webpack:///(webpack)/buildin/global.js","webpack:///./node_modules/core-js/internals/string-trim-forced.js","webpack:///./node_modules/core-js/modules/es.string.small.js","webpack:///../../../src/mixins/elevatable/index.ts","webpack:///./node_modules/core-js/internals/object-keys-internal.js","webpack:///./node_modules/core-js/modules/es.array.includes.js","webpack:///./node_modules/core-js/modules/es.array.fill.js","webpack:///./node_modules/core-js/internals/document-create-element.js","webpack:///./node_modules/core-js/modules/es.object.assign.js","webpack:///./node_modules/core-js/internals/promise-resolve.js","webpack:///./node_modules/core-js/internals/set-global.js","webpack:///./node_modules/axios/lib/axios.js","webpack:///./node_modules/core-js/internals/hidden-keys.js","webpack:///./node_modules/core-js/internals/fails.js","webpack:///./node_modules/core-js/internals/get-built-in.js","webpack:///../../../src/mixins/ssr-bootable/index.ts","webpack:///./node_modules/core-js/internals/object-property-is-enumerable.js","webpack:///./node_modules/core-js/modules/es.symbol.iterator.js","webpack:///./node_modules/core-js/internals/object-set-prototype-of.js","webpack:///./node_modules/core-js/modules/es.object.to-string.js","webpack:///./node_modules/core-js/internals/set-to-string-tag.js","webpack:///./node_modules/core-js/internals/fix-regexp-well-known-symbol-logic.js","webpack:///./node_modules/core-js/modules/es.array.map.js","webpack:///./node_modules/axios/lib/helpers/isAbsoluteURL.js","webpack:///../../src/util/console.ts","webpack:///../../src/util/mergeData.ts","webpack:///./node_modules/core-js/internals/global.js","webpack:///./node_modules/core-js/modules/es.object.get-own-property-descriptors.js","webpack:///./node_modules/core-js/modules/es.object.freeze.js","webpack:///./node_modules/core-js/modules/web.dom-collections.iterator.js","webpack:///./node_modules/core-js/internals/object-keys.js","webpack:///./node_modules/core-js/modules/es.symbol.description.js","webpack:///./node_modules/core-js/internals/object-get-prototype-of.js","webpack:///./node_modules/core-js/internals/correct-prototype-getter.js","webpack:///./node_modules/core-js/modules/es.array.iterator.js","webpack:///./node_modules/core-js/internals/redefine-all.js","webpack:///./node_modules/core-js/modules/es.object.get-own-property-descriptor.js","webpack:///./node_modules/core-js/internals/well-known-symbol-wrapped.js","webpack:///./node_modules/core-js/internals/perform.js","webpack:///./node_modules/axios/lib/helpers/combineURLs.js","webpack:///./node_modules/core-js/modules/es.promise.js","webpack:///./node_modules/core-js/internals/copy-constructor-properties.js","webpack:///./node_modules/core-js/internals/is-array.js","webpack:///./node_modules/core-js/internals/is-array-iterator-method.js","webpack:///./node_modules/core-js/internals/new-promise-capability.js","webpack:///./node_modules/core-js/internals/internal-metadata.js","webpack:///./node_modules/process/browser.js","webpack:///../../../src/mixins/toggleable/index.ts","webpack:///./node_modules/@babel/runtime/helpers/esm/classCallCheck.js","webpack:///./node_modules/@babel/runtime/helpers/esm/createClass.js","webpack:///../src/install.ts","webpack:///./node_modules/@babel/runtime/helpers/esm/objectWithoutPropertiesLoose.js","webpack:///./node_modules/@babel/runtime/helpers/esm/objectWithoutProperties.js","webpack:///./node_modules/@babel/runtime/helpers/esm/setPrototypeOf.js","webpack:///./node_modules/@babel/runtime/helpers/esm/inherits.js","webpack:///./node_modules/@babel/runtime/helpers/esm/getPrototypeOf.js","webpack:///./node_modules/@babel/runtime/helpers/esm/isNativeReflectConstruct.js","webpack:///./node_modules/@babel/runtime/helpers/esm/assertThisInitialized.js","webpack:///./node_modules/@babel/runtime/helpers/esm/possibleConstructorReturn.js","webpack:///./node_modules/@babel/runtime/helpers/esm/createSuper.js","webpack:///../../src/locale/en.ts","webpack:///../../../src/presets/default/index.ts","webpack:///../../../src/services/service/index.ts","webpack:///../../../src/services/presets/index.ts","webpack:///../../../src/services/application/index.ts","webpack:///../../../src/services/breakpoint/index.ts","webpack:///../../../src/services/goto/easing-patterns.ts","webpack:///../../../src/services/goto/util.ts","webpack:///../../../src/services/goto/index.ts","webpack:///../../../../src/services/icons/presets/mdi-svg.ts","webpack:///../../../../src/services/icons/presets/md.ts","webpack:///../../../../src/services/icons/presets/mdi.ts","webpack:///../../../../src/services/icons/presets/fa.ts","webpack:///../../../../src/services/icons/presets/fa4.ts","webpack:///../../../../src/services/icons/presets/fa-svg.ts","webpack:///../../../../src/services/icons/presets/index.ts","webpack:///../../../src/services/icons/index.ts","webpack:///../../../src/services/lang/index.ts","webpack:///../../../src/util/color/transformCIELAB.ts","webpack:///../../../src/services/theme/utils.ts","webpack:///../../../src/services/theme/index.ts","webpack:///../src/framework.ts","webpack:///./node_modules/core-js/internals/classof.js","webpack:///./node_modules/axios/lib/core/InterceptorManager.js","webpack:///../../../src/components/VMain/VMain.ts","webpack:///./node_modules/core-js/internals/math-sign.js","webpack:///./node_modules/core-js/internals/shared-key.js","webpack:///./node_modules/core-js/modules/es.array.slice.js","webpack:///./node_modules/core-js/internals/to-indexed-object.js","webpack:///./node_modules/core-js/internals/dom-iterables.js","webpack:///./node_modules/core-js/internals/use-symbol-as-uid.js","webpack:///../../../src/mixins/positionable/index.ts","webpack:///./node_modules/core-js/internals/native-promise-constructor.js"],"names":["wellKnownSymbol","TO_STRING_TAG","test","module","exports","String","aFunction","fn","that","length","undefined","call","a","b","c","apply","arguments","$","flattenIntoArray","toObject","toLength","toInteger","arraySpeciesCreate","target","proto","flat","depthArg","O","this","sourceLen","A","isObject","slice","factories","construct","C","argsLength","args","list","i","Function","join","bind","partArgs","boundFunction","concat","prototype","toIndexedObject","$getOwnPropertyNames","f","toString","windowNames","window","Object","getOwnPropertyNames","getWindowNames","it","error","_arrayLikeToArray","arr","len","arr2","Array","_unsupportedIterableToArray","o","minLen","arrayLikeToArray","n","constructor","name","from","DESCRIPTORS","propertyIsEnumerableModule","createPropertyDescriptor","toPrimitive","has","IE8_DOM_DEFINE","$getOwnPropertyDescriptor","getOwnPropertyDescriptor","P","$values","values","stat","defaults","utils","InterceptorManager","dispatchRequest","Axios","instanceConfig","interceptors","request","response","config","merge","url","method","toLowerCase","chain","promise","Promise","resolve","forEach","interceptor","unshift","fulfilled","rejected","push","then","shift","data","floor","Math","replace","SUBSTITUTION_SYMBOLS","SUBSTITUTION_SYMBOLS_NO_NAMED","matched","str","position","captures","namedCaptures","replacement","tailPos","m","symbols","match","ch","capture","charAt","fails","createElement","defineProperty","get","callback","breakpoints","ALIGNMENT","makeProps","props","prefix","def","alignValidator","alignProps","type","default","validator","justifyValidator","justifyProps","alignContentValidator","alignContentProps","propMap","align","justify","alignContent","classMap","breakpointClass","className","val","breakpoint","prop","cache","functional","tag","dense","noGutters","render","children","cacheKey","classList","value","h","staticClass","class","requireObjectCoercible","count","result","Infinity","RangeError","fixRegExpWellKnownSymbolLogic","isRegExp","anObject","speciesConstructor","advanceStringIndex","callRegExpExec","regexpExec","stickyHelpers","UNSUPPORTED_Y","arrayPush","min","MAX_UINT32","SPLIT","nativeSplit","maybeCallNative","internalSplit","split","separator","limit","string","lim","lastIndex","lastLength","output","flags","ignoreCase","multiline","unicode","sticky","lastLastIndex","separatorCopy","RegExp","source","index","splitter","regexp","res","done","rx","S","unicodeMatching","p","q","e","z","isFontAwesome5","some","iconType","isSvgPath","icon","SIZE_MAP","VIcon","disabled","left","right","size","Number","required","computed","medium","hasClickListener","Boolean","listeners$","click","methods","getIcon","iconName","$slots","text","getSize","sizes","xSmall","small","large","xLarge","explicitSize","key","getDefaultData","attrs","attrs$","on","getSvgWrapperData","fontSize","wrapperData","style","height","width","applyColors","themeClasses","renderFontIcon","newChildren","delimiterIndex","isMaterialIcon","renderSvgIcon","svgData","xmlns","viewBox","role","d","renderSvgIconComponent","component","$_wrapperFor","classof","R","exec","TypeError","global","DOMIterables","createNonEnumerableProperty","COLLECTION_NAME","Collection","CollectionPrototype","$forEach","arrayMethodIsStrict","STRICT_METHOD","callbackfn","createHTML","forcedStringHTMLMethod","forced","anchor","Constructor","getBuiltIn","ITERATOR","SAFE_CLOSING","called","iteratorWithReturn","next","SKIP_CLOSING","ITERATION_SUPPORT","object","userAgent","thisArg","V8_VERSION","SPECIES","METHOD_NAME","array","foo","isArrayIteratorMethod","getIteratorMethod","iteratorClose","Result","stopped","iterable","unboundFunction","options","iterator","iterFn","step","AS_ENTRIES","IS_ITERATOR","INTERRUPTED","stop","condition","callFn","max","integer","redefine","setGlobal","copyConstructorProperties","isForced","FORCED","targetProperty","sourceProperty","descriptor","TARGET","GLOBAL","STATIC","noTargetGet","sham","internalObjectKeys","enumBugKeys","hiddenKeys","normalizeHeaderName","DEFAULT_CONTENT_TYPE","setContentTypeIfUnset","headers","isUndefined","getDefaultAdapter","adapter","XMLHttpRequest","process","transformRequest","isFormData","isArrayBuffer","isBuffer","isStream","isFile","isBlob","isArrayBufferView","buffer","isURLSearchParams","JSON","stringify","transformResponse","parse","timeout","xsrfCookieName","xsrfHeaderName","maxContentLength","validateStatus","status","common","maxHeight","maxWidth","minHeight","minWidth","measurableStyles","styles","notARegExp","correctIsRegExpLogic","includes","searchString","indexOf","TO_STRING","RegExpPrototype","nativeToString","NOT_GENERIC","INCORRECT_NAME","rf","unsafe","definePropertyModule","CONSTRUCTOR_NAME","configurable","normalizeComponent","scriptExports","staticRenderFns","functionalTemplate","injectStyles","scopeId","moduleIdentifier","shadowMode","hook","_compiled","_scopeId","context","$vnode","ssrContext","parent","__VUE_SSR_CONTEXT__","_registeredComponents","add","_ssrRegister","$root","$options","shadowRoot","_injectStyles","originalRender","existing","beforeCreate","returnMethod","emptyObject","freeze","isUndef","v","isDef","isTrue","isFalse","isPrimitive","obj","_toString","isPlainObject","isValidArrayIndex","parseFloat","isFinite","isPromise","catch","isArray","toNumber","isNaN","makeMap","expectsLowerCase","map","create","isReservedAttribute","remove","item","splice","hasOwnProperty","hasOwn","cached","hit","camelizeRE","camelize","_","toUpperCase","capitalize","hyphenateRE","hyphenate","polyfillBind","ctx","boundFn","l","_length","nativeBind","toArray","start","ret","extend","to","_from","noop","no","identity","looseEqual","isObjectA","isObjectB","isArrayA","isArrayB","every","Date","getTime","keysA","keys","keysB","looseIndexOf","once","SSR_ATTR","ASSET_TYPES","LIFECYCLE_HOOKS","optionMergeStrategies","silent","productionTip","devtools","performance","errorHandler","warnHandler","ignoredElements","keyCodes","isReservedTag","isReservedAttr","isUnknownElement","getTagNamespace","parsePlatformTagName","mustUseProp","async","_lifecycleHooks","unicodeRegExp","isReserved","charCodeAt","enumerable","writable","bailRE","parsePath","path","segments","_isServer","hasProto","inBrowser","inWeex","WXEnvironment","platform","weexPlatform","UA","navigator","isIE","isIE9","isEdge","isIOS","isFF","nativeWatch","watch","supportsPassive","opts","addEventListener","isServerRendering","env","VUE_ENV","__VUE_DEVTOOLS_GLOBAL_HOOK__","isNative","Ctor","_Set","hasSymbol","Symbol","Reflect","ownKeys","Set","set","clear","warn","uid","Dep","id","subs","addSub","sub","removeSub","depend","addDep","notify","update","targetStack","pushTarget","popTarget","pop","VNode","elm","componentOptions","asyncFactory","ns","fnContext","fnOptions","fnScopeId","componentInstance","raw","isStatic","isRootInsert","isComment","isCloned","isOnce","asyncMeta","isAsyncPlaceholder","prototypeAccessors","child","defineProperties","createEmptyVNode","node","createTextVNode","cloneVNode","vnode","cloned","arrayProto","arrayMethods","methodsToPatch","original","inserted","ob","__ob__","observeArray","dep","arrayKeys","shouldObserve","toggleObserving","Observer","vmCount","protoAugment","copyAugment","walk","src","__proto__","observe","asRootData","isExtensible","_isVue","defineReactive$$1","customSetter","shallow","property","getter","setter","childOb","dependArray","newVal","del","items","strats","mergeData","toVal","fromVal","mergeDataOrFn","parentVal","childVal","vm","instanceData","defaultData","mergeHook","dedupeHooks","hooks","mergeAssets","key$1","inject","provide","defaultStrat","normalizeProps","normalizeInject","normalized","normalizeDirectives","dirs","directives","def$$1","mergeOptions","_base","extends","mixins","mergeField","strat","resolveAsset","warnMissing","assets","camelizedId","PascalCaseId","validateProp","propOptions","propsData","absent","booleanIndex","getTypeIndex","stringIndex","getPropDefaultValue","prevShouldObserve","_props","getType","isSameType","expectedTypes","handleError","err","info","cur","$parent","errorCaptured","globalHandleError","invokeWithErrorHandling","handler","_handled","logError","console","timerFunc","isUsingMicroTask","callbacks","pending","flushCallbacks","copies","setTimeout","MutationObserver","setImmediate","counter","observer","textNode","document","createTextNode","characterData","nextTick","cb","_resolve","seenObjects","traverse","_traverse","seen","isA","isFrozen","depId","normalizeEvent","passive","once$$1","createFnInvoker","fns","invoker","arguments$1","updateListeners","oldOn","remove$$1","createOnceHandler","old","event","params","mergeVNodeHook","hookKey","oldHook","wrappedHook","merged","extractPropsFromVNodeData","altKey","checkProp","hash","preserve","simpleNormalizeChildren","normalizeChildren","normalizeArrayChildren","isTextNode","nestedIndex","last","_isVList","initProvide","_provided","initInjections","resolveInject","provideKey","provideDefault","resolveSlots","slots","slot","name$1","isWhitespace","normalizeScopedSlots","normalSlots","prevSlots","hasNormalSlots","isStable","$stable","$key","_normalized","$hasNormal","normalizeScopedSlot","key$2","proxyNormalSlot","proxy","renderList","renderSlot","fallback","bindObject","nodes","scopedSlotFn","$scopedSlots","$createElement","resolveFilter","isKeyNotMatch","expect","actual","checkKeyCodes","eventKeyCode","builtInKeyCode","eventKeyName","builtInKeyName","mappedKeyCode","bindObjectProps","asProp","isSync","loop","domProps","camelizedKey","hyphenatedKey","$event","renderStatic","isInFor","_staticTrees","tree","_renderProxy","markStatic","markOnce","markStaticNode","bindObjectListeners","ours","resolveScopedSlots","hasDynamicKeys","contentHashKey","bindDynamicKeys","baseObj","prependModifier","symbol","installRenderHelpers","_o","_n","_s","_l","_t","_q","_i","_m","_f","_k","_b","_v","_e","_u","_g","_d","_p","FunctionalRenderContext","contextVm","this$1","_original","isCompiled","needNormalization","listeners","injections","scopedSlots","_c","createFunctionalComponent","mergeProps","renderContext","cloneAndMarkFunctionalResult","vnodes","clone","componentVNodeHooks","init","hydrating","_isDestroyed","keepAlive","mountedNode","prepatch","createComponentInstanceForVnode","activeInstance","$mount","oldVnode","updateChildComponent","insert","_isMounted","callHook","queueActivatedComponent","activateChildComponent","destroy","deactivateChildComponent","$destroy","hooksToMerge","createComponent","baseCtor","cid","resolveAsyncComponent","createAsyncPlaceholder","resolveConstructorOptions","model","transformModel","nativeOn","abstract","installComponentHooks","_isComponent","_parentVnode","inlineTemplate","toMerge","_merged","mergeHook$1","f1","f2","SIMPLE_NORMALIZE","ALWAYS_NORMALIZE","normalizationType","alwaysNormalize","_createElement","is","pre","applyNS","registerDeepBindings","force","initRender","_vnode","parentVnode","_renderChildren","parentData","_parentListeners","currentRenderingInstance","renderMixin","Vue","$nextTick","_render","ref","ensureCtor","comp","base","__esModule","toStringTag","factory","errorComp","resolved","owner","owners","loading","loadingComp","sync","timerLoading","timerTimeout","$on","forceRender","renderCompleted","$forceUpdate","clearTimeout","reject","reason","delay","getFirstComponentChild","initEvents","_events","_hasHookEvent","updateComponentListeners","remove$1","$off","_target","onceHandler","oldListeners","eventsMixin","hookRE","$once","i$1","cbs","$emit","setActiveInstance","prevActiveInstance","initLifecycle","$children","$refs","_watcher","_inactive","_directInactive","_isBeingDestroyed","lifecycleMixin","_update","prevEl","$el","prevVnode","restoreActiveInstance","__patch__","__vue__","teardown","_watchers","_data","mountComponent","el","updateComponent","Watcher","before","renderChildren","newScopedSlots","oldScopedSlots","hasDynamicScopedSlot","needsForceUpdate","$attrs","$listeners","propKeys","_propKeys","isInInactiveTree","direct","handlers","j","queue","activatedChildren","waiting","flushing","resetSchedulerState","currentFlushTimestamp","getNow","now","createEvent","timeStamp","flushSchedulerQueue","watcher","sort","run","activatedQueue","updatedQueue","callActivatedHooks","callUpdatedHooks","emit","queueWatcher","uid$2","expOrFn","isRenderWatcher","deep","user","lazy","active","dirty","deps","newDeps","depIds","newDepIds","expression","cleanupDeps","tmp","oldValue","evaluate","sharedPropertyDefinition","sourceKey","initState","initProps","initMethods","initData","initComputed","initWatch","propsOptions","isRoot","getData","computedWatcherOptions","watchers","_computedWatchers","isSSR","userDef","defineComputed","shouldCache","createComputedGetter","createGetterInvoker","createWatcher","$watch","stateMixin","dataDef","propsDef","$set","$delete","immediate","uid$3","initMixin","_init","_uid","initInternalComponent","_self","vnodeComponentOptions","_componentTag","super","superOptions","cachedSuperOptions","modifiedOptions","resolveModifiedOptions","extendOptions","components","modified","latest","sealed","sealedOptions","initUse","use","plugin","installedPlugins","_installedPlugins","install","initMixin$1","mixin","initExtend","Super","SuperId","cachedCtors","_Ctor","Sub","initProps$1","initComputed$1","Comp","initAssetRegisters","definition","getComponentName","matches","pattern","pruneCache","keepAliveInstance","filter","cachedNode","pruneCacheEntry","current","cached$$1","patternTypes","KeepAlive","include","exclude","created","destroyed","mounted","ref$1","parseInt","builtInComponents","initGlobalAPI","configDef","util","defineReactive","delete","observable","version","acceptValue","attr","isEnumeratedAttr","isValidContentEditableValue","convertEnumeratedValue","isFalsyAttrValue","isBooleanAttr","xlinkNS","isXlink","getXlinkProp","genClassForVnode","parentNode","childNode","mergeClassData","renderClass","dynamicClass","stringifyClass","stringifyArray","stringifyObject","stringified","namespaceMap","svg","math","isHTMLTag","isSVG","unknownElementCache","HTMLUnknownElement","HTMLElement","isTextInputType","query","selected","querySelector","createElement$1","tagName","multiple","setAttribute","createElementNS","namespace","createComment","insertBefore","newNode","referenceNode","removeChild","appendChild","nextSibling","setTextContent","textContent","setStyleScope","nodeOps","registerRef","isRemoval","refs","refInFor","emptyNode","sameVnode","sameInputType","typeA","typeB","createKeyToOldIdx","beginIdx","endIdx","createPatchFunction","backend","modules","emptyNodeAt","createRmCb","childElm","removeNode","createElm","insertedVnodeQueue","parentElm","refElm","nested","ownerArray","setScope","createChildren","invokeCreateHooks","isReactivated","initComponent","reactivateComponent","pendingInsert","isPatchable","innerNode","transition","activate","ref$$1","ancestor","addVnodes","startIdx","invokeDestroyHook","removeVnodes","removeAndInvokeRemoveHook","rm","updateChildren","oldCh","newCh","removeOnly","oldKeyToIdx","idxInOld","vnodeToMove","oldStartIdx","newStartIdx","oldEndIdx","oldStartVnode","oldEndVnode","newEndIdx","newStartVnode","newEndVnode","canMove","patchVnode","findIdxInOld","end","hydrate","postpatch","invokeInsertHook","initial","isRenderedModule","inVPre","hasChildNodes","innerHTML","childrenMatch","firstChild","fullInvoke","isInitialPatch","isRealElement","nodeType","hasAttribute","removeAttribute","oldElm","_leaveCb","patchable","i$2","updateDirectives","oldDir","dir","isCreate","isDestroy","oldDirs","normalizeDirectives$1","newDirs","dirsWithInsert","dirsWithPostpatch","oldArg","arg","callHook$1","componentUpdated","callInsert","emptyModifiers","modifiers","getRawDirName","rawName","baseModules","updateAttrs","inheritAttrs","oldAttrs","setAttr","removeAttributeNS","baseSetAttr","setAttributeNS","__ieph","blocker","stopImmediatePropagation","removeEventListener","updateClass","oldData","cls","transitionClass","_transitionClasses","_prevClass","target$1","klass","RANGE_TOKEN","CHECKBOX_RADIO_TOKEN","normalizeEvents","change","createOnceHandler$1","remove$2","useMicrotaskFix","add$1","attachedTimestamp","_wrapper","currentTarget","ownerDocument","updateDOMListeners","svgContainer","events","updateDOMProps","oldProps","childNodes","_value","strCur","shouldUpdateValue","checkVal","composing","isNotInFocusAndDirty","isDirtyWithModifiers","notInFocus","activeElement","_vModifiers","number","trim","parseStyleText","cssText","listDelimiter","propertyDelimiter","normalizeStyleData","normalizeStyleBinding","staticStyle","bindingStyle","getStyle","checkChild","styleData","emptyStyle","cssVarRE","importantRE","setProp","setProperty","normalizedName","normalize","vendorNames","capName","updateStyle","oldStaticStyle","oldStyleBinding","normalizedStyle","oldStyle","newStyle","whitespaceRE","addClass","getAttribute","removeClass","tar","resolveTransition","css","autoCssTransition","enterClass","enterToClass","enterActiveClass","leaveClass","leaveToClass","leaveActiveClass","hasTransition","TRANSITION","ANIMATION","transitionProp","transitionEndEvent","animationProp","animationEndEvent","ontransitionend","onwebkittransitionend","onanimationend","onwebkitanimationend","raf","requestAnimationFrame","nextFrame","addTransitionClass","transitionClasses","removeTransitionClass","whenTransitionEnds","expectedType","getTransitionInfo","propCount","ended","onEnd","transformRE","getComputedStyle","transitionDelays","transitionDurations","transitionTimeout","getTimeout","animationDelays","animationDurations","animationTimeout","hasTransform","delays","durations","toMs","s","enter","toggleDisplay","cancelled","_enterCb","appearClass","appearToClass","appearActiveClass","beforeEnter","afterEnter","enterCancelled","beforeAppear","appear","afterAppear","appearCancelled","duration","transitionNode","isAppear","startClass","activeClass","toClass","beforeEnterHook","enterHook","afterEnterHook","enterCancelledHook","explicitEnterDuration","expectsCSS","userWantsControl","getHookArgumentsLength","show","pendingNode","_pending","isValidDuration","leave","beforeLeave","afterLeave","leaveCancelled","delayLeave","explicitLeaveDuration","performLeave","invokerFns","_enter","platformModules","patch","vmodel","trigger","directive","binding","_vOptions","setSelected","getValue","onCompositionStart","onCompositionEnd","prevOptions","curOptions","needReset","hasNoMatchingOption","actuallySetSelected","isMultiple","option","selectedIndex","initEvent","dispatchEvent","locateNode","transition$$1","originalDisplay","__vOriginalDisplay","display","unbind","platformDirectives","transitionProps","mode","getRealChild","compOptions","extractTransitionData","placeholder","rawChild","hasParentTransition","isSameChild","oldChild","isNotTextNode","isVShowDirective","Transition","_leaving","oldRawChild","delayedLeave","moveClass","TransitionGroup","beforeMount","kept","prevChildren","rawChildren","transitionData","removed","c$1","pos","getBoundingClientRect","updated","hasMove","callPendingCbs","recordPosition","applyTranslation","_reflow","body","offsetHeight","moved","transform","WebkitTransform","transitionDuration","_moveCb","propertyName","_hasMove","cloneNode","newPos","oldPos","dx","dy","top","platformComponents","IS_PURE","$startsWith","startsWith","CORRECT_IS_REGEXP_LOGIC","MDN_POLYFILL_BUG","search","defer","channel","port","html","IS_IOS","IS_NODE","location","clearImmediate","MessageChannel","Dispatch","ONREADYSTATECHANGE","runner","listener","post","postMessage","protocol","host","port2","port1","onmessage","importScripts","versions","v8","enhanceError","message","code","Error","__CANCEL__","encode","encodeURIComponent","paramsSerializer","serializedParams","parts","isDate","toISOString","nativeGetPrototypeOf","CORRECT_PROTOTYPE_GETTER","FAILS_ON_PRIMITIVES","getPrototypeOf","Iterators","objectKeys","Properties","_arrayWithHoles","_iterableToArrayLimit","_arr","_nonIterableRest","_slicedToArray","arrayWithHoles","iterableToArrayLimit","unsupportedIterableToArray","nonIterableRest","repeat","isStandardBrowserEnv","originURL","msie","urlParsingNode","resolveURL","href","hostname","pathname","requestURL","parsed","isString","InternalStateModule","defineIterator","STRING_ITERATOR","setInternalState","getInternalState","getterFor","iterated","point","state","sign","abs","pow","cbrt","x","VSheet","absolute","bottom","collapse","extended","extensionHeight","floating","prominent","short","isExtended","computedHeight","isCollapsed","computedContentHeight","isProminent","$vuetify","classes","breakingProps","genBackground","image","img","VImg","genContent","genExtension","setBackgroundColor","self","Scroll","app","applicationProperty","prev","removeApplication","activated","deactivated","callUpdate","updateApplication","scrollTarget","scrollThreshold","currentScroll","currentThreshold","isActive","isScrollingUp","previousScroll","savedScroll","canScroll","computedScrollThreshold","onScroll","thresholdMet","baseMixins","VAppBar","clippedLeft","clippedRight","collapseOnScroll","elevateOnScroll","fadeImgOnScroll","hideOnScroll","invertedScroll","scrollOffScreen","shrinkOnScroll","scrollRatio","threshold","computedFontSize","computedLeft","application","computedMarginTop","computedOpacity","computedOriginalHeight","computedRight","computedTransform","hideShadow","marginTop","opacity","propertyIsEnumerable","UNSCOPABLES","ArrayPrototype","MATCH","regExpExec","nativeMatch","matcher","fullUnicode","matchStr","createError","defaultConstructor","getOwnPropertySymbols","$trim","forcedStringTrimMethod","nativeConstruct","NEW_TARGET_BUG","F","ARGS_BUG","Target","newTarget","$args","instance","toAbsoluteIndex","createMethod","IS_INCLUDES","$this","fromIndex","$filter","arrayMethodHasSpeciesSupport","HAS_SPECIES_SUPPORT","callWithSafeIterationClosing","createProperty","arrayLike","argumentsLength","mapfn","mapping","iteratorMethod","collection","collectionStrong","argument","transformData","isCancel","isAbsoluteURL","combineURLs","throwIfCancellationRequested","cancelToken","throwIfRequested","baseURL","getSubstitution","maybeToString","REPLACE","nativeReplace","REGEXP_REPLACE_SUBSTITUTES_UNDEFINED_CAPTURE","REPLACE_KEEPS_$0","UNSAFE_SUBSTITUTE","searchValue","replaceValue","replacer","functionalReplace","results","accumulatedResult","nextSourcePosition","groups","replacerArgs","_typeof","enumerableOnly","sym","_objectSpread2","getOwnPropertyDescriptors","store","copyright","getOwnPropertyNamesModule","getOwnPropertySymbolsModule","whitespaces","whitespace","ltrim","rtrim","TYPE","bitmap","IndexedObject","$assign","assign","B","alphabet","chr","T","breakpointProps","offsetProps","orderProps","col","offset","order","cols","alignSelf","hasColClasses","CONVERT_TO_STRING","first","second","codeAt","redefineAll","anInstance","iterate","setSpecies","fastKey","internalStateGetterFor","getConstructor","wrapper","IS_MAP","ADDER","define","previous","entry","getEntry","setStrong","ITERATOR_NAME","getInternalCollectionState","getInternalIteratorState","kind","originalArray","NATIVE_WEAK_MAP","objectHas","shared","sharedKey","OBJECT_ALREADY_INITIALIZED","WeakMap","enforce","wmget","wmhas","wmset","metadata","facade","STATE","InternalMetadataModule","checkCorrectnessOfIteration","setToStringTag","inheritIfRequired","IS_WEAK","NativeConstructor","NativePrototype","exported","fixMethod","KEY","nativeMethod","entries","REQUIRED","HASNT_CHAINING","THROWS_ON_PRIMITIVES","ACCEPT_ITERABLES","BUGGY_ZERO","$instance","dummy","inspectSource","enforceInternalState","TEMPLATE","simple","TO_ENTRIES","setPrototypeOf","Wrapper","NewTarget","NewTargetPrototype","wrappedWellKnownSymbolModule","NAME","dark","light","isDark","theme","Themeable","themeableProvide","appIsDark","rootIsDark","rootThemeClasses","Cancel","write","expires","domain","secure","cookie","isNumber","toGMTString","read","decodeURIComponent","color","rgb","char","hexColor","intToHex","colorToInt","activeXDocument","documentCreateElement","GT","LT","PROTOTYPE","SCRIPT","IE_PROTO","EmptyConstructor","scriptTag","content","NullProtoObjectViaActiveX","close","temp","parentWindow","NullProtoObjectViaIFrame","iframeDocument","iframe","JS","contentWindow","open","NullProtoObject","ActiveXObject","$find","find","addToUnscopables","FIND","SKIPS_HOLES","createIteratorConstructor","IteratorsCore","IteratorPrototype","BUGGY_SAFARI_ITERATORS","KEYS","VALUES","ENTRIES","returnThis","Iterable","IteratorConstructor","DEFAULT","IS_SET","CurrentIteratorPrototype","getIterationMethod","KIND","defaultIterator","IterablePrototype","INCORRECT_VALUES_NAME","nativeIterator","anyNativeIterator","makeWatcher","$data","testListenerOpts","getNestedValue","filtered","unit","tab","esc","space","up","down","home","backspace","pageup","pagedown","iconPath","override","getObjectValueByPath","optional","chunked","mergeDeep","endPos","intersect","button","indeterminate","rotate","radius","isVisible","calculatedSize","circumference","normalizedValue","strokeDashArray","strokeDashOffset","strokeWidth","svgStyles","viewBoxSize","genCircle","fill","cx","cy","r","genSvg","genInfo","onObserve","setTextColor","generateWarning","defaultImpl","register","unregister","groupClasses","beforeDestroy","toggle","rippleStop","DELAY_RIPPLE","isTouchEvent","isKeyboardEvent","calculate","localX","localY","scale","centerX","centerY","y","ripples","container","animation","hide","diff","isRippleEnabled","rippleShow","element","rippleHide","rippleCancelShow","keyboardRipple","keyboardRippleShow","keyboardRippleHide","focusRippleHide","updateRipple","enabled","removeListeners","wasEnabled","Ripple","append","exact","exactActiveClass","link","nuxt","ripple","proxyClass","computedRipple","isClickable","isLink","$route","generateRouteLink","tabindex","onRouteChange","btnToggle","block","depressed","fab","outlined","plain","retainFocusOnClick","rounded","tile","sizeableClasses","computedElevation","defaultRipple","circle","hasBg","isElevated","elevation","isRound","genLoader","loader","setColor","propertyKey","quot","attribute","p1","functionToString","$endsWith","endsWith","endPosition","srgbForwardMatrix","srgbForwardTransform","srgbReverseMatrix","srgbReverseTransform","matrix","xyz","g","roundedClasses","composite","shaped","CancelToken","executor","resolvePromise","token","cancel","IntersectionObserver","isIntersecting","Intersect","postfix","random","regexpFlags","nativeExec","patchedExec","UPDATES_LAST_INDEX_WRONG","re1","re2","BROKEN_CARET","NPCG_INCLUDED","PATCH","reCopy","re","charsAdded","strCopy","input","feature","detection","POLYFILL","NATIVE","IS_CONCAT_SPREADABLE","MAX_SAFE_INTEGER","MAXIMUM_ALLOWED_INDEX_EXCEEDED","IS_CONCAT_SPREADABLE_SUPPORT","SPECIES_SUPPORT","isConcatSpreadable","spreadable","k","E","$defineProperty","Attributes","RE","nativeJoin","ES3_STRINGS","depth","mapper","targetIndex","sourceIndex","mapFn","NATIVE_SYMBOL","USE_SYMBOL_AS_UID","nativeObjectCreate","getOwnPropertyNamesExternal","getOwnPropertyDescriptorModule","defineWellKnownSymbol","HIDDEN","SYMBOL","TO_PRIMITIVE","ObjectPrototype","$Symbol","$stringify","nativeGetOwnPropertyDescriptor","nativeDefineProperty","nativeGetOwnPropertyNames","nativePropertyIsEnumerable","AllSymbols","ObjectPrototypeSymbols","StringToSymbolRegistry","SymbolToStringRegistry","WellKnownSymbolsStore","QObject","USE_SETTER","findChild","setSymbolDescriptor","ObjectPrototypeDescriptor","wrap","description","isSymbol","$defineProperties","properties","$getOwnPropertySymbols","$propertyIsEnumerable","$create","V","names","IS_OBJECT_PROTOTYPE","keyFor","useSetter","useSimple","FORCED_JSON_STRINGIFY","$replacer","valueOf","fluid","INCORRECT_ITERATION","ceil","NativePromise","promiseResolve","NON_GENERIC","real","onFinally","isFunction","colorName","NUMBER","NativeNumber","NumberPrototype","BROKEN_CLASSOF","third","radix","maxCode","digits","NaN","NumberWrapper","error1","error2","dotAll","aspectRatio","contentClass","computedAspectRatio","aspectStyle","paddingBottom","__cachedSizer","hasIntersect","alt","contain","eager","gradient","lazySrc","root","rootMargin","srcset","currentSrc","isLoading","calculatedAspectRatio","naturalWidth","hasError","normalisedSrc","aspect","__cachedImage","backgroundImage","backgroundPosition","loadImage","lazyImg","onLoad","naturalHeight","onError","getSrc","pollForSize","poll","__genPlaceholder","_defineProperty","PrototypeOfArrayIteratorPrototype","arrayIterator","NEW_ITERATOR_PROTOTYPE","TO_STRING_TAG_SUPPORT","FunctionPrototype","FunctionPrototypeToString","nameRE","settle","buildURL","parseHeaders","isURLSameOrigin","requestData","requestHeaders","auth","username","password","Authorization","btoa","onreadystatechange","readyState","responseURL","responseHeaders","getAllResponseHeaders","responseData","responseType","responseText","statusText","onerror","ontimeout","cookies","xsrfValue","withCredentials","setRequestHeader","onDownloadProgress","onUploadProgress","upload","abort","send","flush","head","macrotask","IS_WEBOS_WEBKIT","WebKitMutationObserver","queueMicrotaskDescriptor","queueMicrotask","exit","task","createWellKnownSymbol","withoutSetter","nativeKeys","thisNumberValue","nativeToFixed","toFixed","acc","log","x2","multiply","c2","divide","dataToString","t","fractionDigits","fractDigits","IS_FILTER","IS_SOME","IS_EVERY","IS_FIND_INDEX","IS_FILTER_OUT","NO_HOLES","specificCreate","findIndex","filterOut","_createForOfIteratorHelper","allowArrayLike","normalCompletion","didErr","_e2","preventExtensions","PREFERRED_STRING","ignoreDuplicateOf","line","substr","FormData","ArrayBuffer","isView","pipe","URLSearchParams","product","assignValue","SHARED","fixed","non","elevationClasses","$includes","EXISTS","newPromiseCapability","promiseCapability","createInstance","defaultConfig","axios","all","promises","spread","variable","isBooted","NASHORN_BUG","1","aPossiblePrototype","CORRECT_SETTER","TAG","REPLACE_SUPPORTS_NAMED_GROUPS","SPLIT_WORKS_WITH_OVERWRITTEN_EXEC","originalExec","DELEGATES_TO_SYMBOL","DELEGATES_TO_EXEC","execCalled","nativeRegExpMethod","arg2","forceStringMethod","$exec","stringMethod","regexMethod","$map","createMessage","generateComponentTrace","newMessage","consoleError","classifyRE","classify","formatComponentName","file","includeFile","currentRecursiveSequence","styleList","styleProp","parseStyle","styleMap","mergeTarget","mergeClasses","mergeStyles","mergeListeners","dest","check","globalThis","FREEZING","onFreeze","$freeze","ArrayIteratorMethods","ArrayValues","NativeSymbol","EmptyStringDescriptionStore","SymbolWrapper","symbolPrototype","symbolToString","native","desc","ARRAY_ITERATOR","Arguments","relativeURL","Internal","OwnPromiseCapability","PromiseWrapper","nativeThen","microtask","hostReportErrors","newPromiseCapabilityModule","perform","IS_BROWSER","PROMISE","getInternalPromiseState","NativePromisePrototype","PromiseConstructor","PromiseConstructorPrototype","newGenericPromiseCapability","DISPATCH_EVENT","NATIVE_REJECTION_EVENT","PromiseRejectionEvent","UNHANDLED_REJECTION","REJECTION_HANDLED","PENDING","FULFILLED","REJECTED","HANDLED","UNHANDLED","SUBCLASSING","GLOBAL_CORE_JS_PROMISE","FakePromise","isThenable","isReject","notified","reactions","ok","exited","reaction","fail","rejection","onHandleUnhandled","onUnhandled","IS_UNHANDLED","isUnhandled","unwrap","internalReject","internalResolve","onFulfilled","onRejected","capability","$promiseResolve","remaining","alreadyCalled","race","PromiseCapability","$$resolve","$$reject","METADATA","setMetadata","objectID","weakData","getWeakData","meta","cachedSetTimeout","cachedClearTimeout","defaultSetTimout","defaultClearTimeout","runTimeout","fun","runClearTimeout","marker","currentQueue","draining","queueIndex","cleanUpNextTick","drainQueue","Item","title","browser","argv","addListener","off","removeListener","removeAllListeners","prependListener","prependOnceListener","cwd","chdir","umask","Toggleable","_classCallCheck","_defineProperties","_createClass","protoProps","staticProps","registerComponents","vuetify","_objectWithoutPropertiesLoose","excluded","sourceKeys","_objectWithoutProperties","objectWithoutPropertiesLoose","sourceSymbolKeys","_setPrototypeOf","_inherits","subClass","superClass","_getPrototypeOf","_isNativeReflectConstruct","Proxy","_assertThisInitialized","ReferenceError","_possibleConstructorReturn","assertThisInitialized","_createSuper","Derived","hasNativeReflectConstruct","isNativeReflectConstruct","possibleConstructorReturn","badge","dataIterator","noResultsText","loadingText","dataTable","itemsPerPageText","ariaLabel","sortDescending","sortAscending","sortNone","activateNone","activateDescending","activateAscending","sortBy","dataFooter","itemsPerPageAll","nextPage","prevPage","firstPage","lastPage","pageText","datePicker","itemsSelected","nextMonthAriaLabel","nextYearAriaLabel","prevMonthAriaLabel","prevYearAriaLabel","noDataText","carousel","delimiter","calendar","moreEvents","fileInput","counterSize","timePicker","am","pm","pagination","page","currentPage","rating","mobileBreakpoint","scrollBarWidth","thresholds","xs","sm","md","lg","icons","iconfont","lang","locales","en","rtl","disable","cspNonce","customProperties","minifyTheme","themeCache","variations","themes","primary","secondary","accent","success","warning","framework","defaultPreset","userPreset","preset","globalPreset","bar","insetFooter","footer","xl","xsOnly","smOnly","smAndDown","smAndUp","mdOnly","mdAndDown","mdAndUp","lgOnly","lgAndDown","lgAndUp","xlOnly","mobile","resizeTimeout","Breakpoint","onResize","ssr","linear","easeInQuad","easeOutQuad","easeInOutQuad","easeInCubic","easeOutCubic","easeInOutCubic","easeInQuart","easeOutQuart","easeInOutQuart","easeInQuint","easeOutQuint","easeInOutQuint","totalOffset","_settings","settings","easing","appOffset","getContainer","goTo","isDrawer","isClipped","startTime","targetLocation","getOffset","startLocation","ease","timeElapsed","currentTime","progress","clientHeight","complete","checkboxOn","checkboxOff","checkboxIndeterminate","expand","menu","subgroup","dropdown","radioOn","radioOff","edit","ratingEmpty","ratingFull","ratingHalf","unfold","plus","minus","iconSet","convertToComponentDeclarations","mdiSvg","mdi","fa","fa4","faSvg","Icons","presets","LANG_PREFIX","getTranslation","usingDefault","shortKey","translation","locale","defaultLocale","Lang","translator","currentLocale","delta","cielabForwardTransform","cielabReverseTransform","transformedY","Ln","lab","isItem","variant","colors","parsedTheme","genVariations","genBaseColor","genColorVariableName","genColorVariable","cssVar","variablesCss","aColor","variants","variantValue","lighten","darken","amount","unwatch","vueMeta","Theme","styleEl","oldDark","defaultTheme","metaKeyName","getOptions","metaInfo","vuetifyStylesheet","nonce","addApp","obs","currentTheme","isHydrating","installed","service","Service","classofRaw","CORRECT_ARGUMENTS","tryGet","callee","eject","paddingTop","paddingRight","paddingLeft","nativeSlice","fin","CSSRuleList","CSSStyleDeclaration","CSSValueList","ClientRectList","DOMRectList","DOMStringList","DOMTokenList","DataTransferItemList","FileList","HTMLAllCollection","HTMLCollection","HTMLFormElement","HTMLSelectElement","MediaList","MimeTypeArray","NamedNodeMap","NodeList","PaintRequestList","Plugin","PluginArray","SVGLengthList","SVGNumberList","SVGPathSegList","SVGPointList","SVGStringList","SVGTransformList","SourceBufferList","StyleSheetList","TextTrackCueList","TextTrackList","TouchList","availableProps"],"mappings":"oGAAA,IAAIA,EAAkB,EAAQ,QAE1BC,EAAgBD,EAAgB,eAChCE,EAAO,GAEXA,EAAKD,GAAiB,IAEtBE,EAAOC,QAA2B,eAAjBC,OAAOH,I,uBCPxB,IAAII,EAAY,EAAQ,QAGxBH,EAAOC,QAAU,SAAUG,EAAIC,EAAMC,GAEnC,GADAH,EAAUC,QACGG,IAATF,EAAoB,OAAOD,EAC/B,OAAQE,GACN,KAAK,EAAG,OAAO,WACb,OAAOF,EAAGI,KAAKH,IAEjB,KAAK,EAAG,OAAO,SAAUI,GACvB,OAAOL,EAAGI,KAAKH,EAAMI,IAEvB,KAAK,EAAG,OAAO,SAAUA,EAAGC,GAC1B,OAAON,EAAGI,KAAKH,EAAMI,EAAGC,IAE1B,KAAK,EAAG,OAAO,SAAUD,EAAGC,EAAGC,GAC7B,OAAOP,EAAGI,KAAKH,EAAMI,EAAGC,EAAGC,IAG/B,OAAO,WACL,OAAOP,EAAGQ,MAAMP,EAAMQ,c,oCCpB1B,IAAIC,EAAI,EAAQ,QACZC,EAAmB,EAAQ,QAC3BC,EAAW,EAAQ,QACnBC,EAAW,EAAQ,QACnBC,EAAY,EAAQ,QACpBC,EAAqB,EAAQ,QAIjCL,EAAE,CAAEM,OAAQ,QAASC,OAAO,GAAQ,CAClCC,KAAM,WACJ,IAAIC,EAAWV,UAAUP,OAASO,UAAU,QAAKN,EAC7CiB,EAAIR,EAASS,MACbC,EAAYT,EAASO,EAAElB,QACvBqB,EAAIR,EAAmBK,EAAG,GAE9B,OADAG,EAAErB,OAASS,EAAiBY,EAAGH,EAAGA,EAAGE,EAAW,OAAgBnB,IAAbgB,EAAyB,EAAIL,EAAUK,IACnFI,M,oCChBX,IAAIxB,EAAY,EAAQ,QACpByB,EAAW,EAAQ,QAEnBC,EAAQ,GAAGA,MACXC,EAAY,GAEZC,EAAY,SAAUC,EAAGC,EAAYC,GACvC,KAAMD,KAAcH,GAAY,CAC9B,IAAK,IAAIK,EAAO,GAAIC,EAAI,EAAGA,EAAIH,EAAYG,IAAKD,EAAKC,GAAK,KAAOA,EAAI,IAErEN,EAAUG,GAAcI,SAAS,MAAO,gBAAkBF,EAAKG,KAAK,KAAO,KAC3E,OAAOR,EAAUG,GAAYD,EAAGE,IAKpClC,EAAOC,QAAUoC,SAASE,MAAQ,SAAclC,GAC9C,IAAID,EAAKD,EAAUsB,MACfe,EAAWX,EAAMrB,KAAKK,UAAW,GACjC4B,EAAgB,WAClB,IAAIP,EAAOM,EAASE,OAAOb,EAAMrB,KAAKK,YACtC,OAAOY,gBAAgBgB,EAAgBV,EAAU3B,EAAI8B,EAAK5B,OAAQ4B,GAAQ9B,EAAGQ,MAAMP,EAAM6B,IAG3F,OADIN,EAASxB,EAAGuC,aAAYF,EAAcE,UAAYvC,EAAGuC,WAClDF,I,uBCxBT,IAAIG,EAAkB,EAAQ,QAC1BC,EAAuB,EAAQ,QAA8CC,EAE7EC,EAAW,GAAGA,SAEdC,EAA+B,iBAAVC,QAAsBA,QAAUC,OAAOC,oBAC5DD,OAAOC,oBAAoBF,QAAU,GAErCG,EAAiB,SAAUC,GAC7B,IACE,OAAOR,EAAqBQ,GAC5B,MAAOC,GACP,OAAON,EAAYnB,UAKvB7B,EAAOC,QAAQ6C,EAAI,SAA6BO,GAC9C,OAAOL,GAAoC,mBAArBD,EAASvC,KAAK6C,GAChCD,EAAeC,GACfR,EAAqBD,EAAgBS,M,wHCrB5B,SAASE,EAAkBC,EAAKC,IAClC,MAAPA,GAAeA,EAAMD,EAAIlD,UAAQmD,EAAMD,EAAIlD,QAE/C,IAAK,IAAI8B,EAAI,EAAGsB,EAAO,IAAIC,MAAMF,GAAMrB,EAAIqB,EAAKrB,IAC9CsB,EAAKtB,GAAKoB,EAAIpB,GAGhB,OAAOsB,ECNM,SAASE,EAA4BC,EAAGC,GACrD,GAAKD,EAAL,CACA,GAAiB,kBAANA,EAAgB,OAAOE,EAAiBF,EAAGC,GACtD,IAAIE,EAAId,OAAOP,UAAUI,SAASvC,KAAKqD,GAAGhC,MAAM,GAAI,GAEpD,MADU,WAANmC,GAAkBH,EAAEI,cAAaD,EAAIH,EAAEI,YAAYC,MAC7C,QAANF,GAAqB,QAANA,EAAoBL,MAAMQ,KAAKN,GACxC,cAANG,GAAqB,2CAA2CjE,KAAKiE,GAAWD,EAAiBF,EAAGC,QAAxG,K,uBCPF,IAAIM,EAAc,EAAQ,QACtBC,EAA6B,EAAQ,QACrCC,EAA2B,EAAQ,QACnC1B,EAAkB,EAAQ,QAC1B2B,EAAc,EAAQ,QACtBC,EAAM,EAAQ,QACdC,EAAiB,EAAQ,QAGzBC,EAA4BxB,OAAOyB,yBAIvC1E,EAAQ6C,EAAIsB,EAAcM,EAA4B,SAAkClD,EAAGoD,GAGzF,GAFApD,EAAIoB,EAAgBpB,GACpBoD,EAAIL,EAAYK,GAAG,GACfH,EAAgB,IAClB,OAAOC,EAA0BlD,EAAGoD,GACpC,MAAOtB,IACT,GAAIkB,EAAIhD,EAAGoD,GAAI,OAAON,GAA0BD,EAA2BvB,EAAEtC,KAAKgB,EAAGoD,GAAIpD,EAAEoD,M,uBCnB7F,IAAI9D,EAAI,EAAQ,QACZ+D,EAAU,EAAQ,QAAgCC,OAItDhE,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,GAAQ,CAClCD,OAAQ,SAAgBtD,GACtB,OAAOqD,EAAQrD,O,oCCLnB,IAAIwD,EAAW,EAAQ,QACnBC,EAAQ,EAAQ,QAChBC,EAAqB,EAAQ,QAC7BC,EAAkB,EAAQ,QAO9B,SAASC,EAAMC,GACb5D,KAAKuD,SAAWK,EAChB5D,KAAK6D,aAAe,CAClBC,QAAS,IAAIL,EACbM,SAAU,IAAIN,GASlBE,EAAMzC,UAAU4C,QAAU,SAAiBE,GAGnB,kBAAXA,IACTA,EAASR,EAAMS,MAAM,CACnBC,IAAK9E,UAAU,IACdA,UAAU,KAGf4E,EAASR,EAAMS,MAAMV,EAAU,CAACY,OAAQ,OAAQnE,KAAKuD,SAAUS,GAC/DA,EAAOG,OAASH,EAAOG,OAAOC,cAG9B,IAAIC,EAAQ,CAACX,OAAiB5E,GAC1BwF,EAAUC,QAAQC,QAAQR,GAE9BhE,KAAK6D,aAAaC,QAAQW,SAAQ,SAAoCC,GACpEL,EAAMM,QAAQD,EAAYE,UAAWF,EAAYG,aAGnD7E,KAAK6D,aAAaE,SAASU,SAAQ,SAAkCC,GACnEL,EAAMS,KAAKJ,EAAYE,UAAWF,EAAYG,aAGhD,MAAOR,EAAMxF,OACXyF,EAAUA,EAAQS,KAAKV,EAAMW,QAASX,EAAMW,SAG9C,OAAOV,GAITd,EAAMiB,QAAQ,CAAC,SAAU,MAAO,OAAQ,YAAY,SAA6BN,GAE/ER,EAAMzC,UAAUiD,GAAU,SAASD,EAAKF,GACtC,OAAOhE,KAAK8D,QAAQN,EAAMS,MAAMD,GAAU,GAAI,CAC5CG,OAAQA,EACRD,IAAKA,SAKXV,EAAMiB,QAAQ,CAAC,OAAQ,MAAO,UAAU,SAA+BN,GAErER,EAAMzC,UAAUiD,GAAU,SAASD,EAAKe,EAAMjB,GAC5C,OAAOhE,KAAK8D,QAAQN,EAAMS,MAAMD,GAAU,GAAI,CAC5CG,OAAQA,EACRD,IAAKA,EACLe,KAAMA,SAKZ1G,EAAOC,QAAUmF,G,uBC9EjB,IAAIpE,EAAW,EAAQ,QAEnB2F,EAAQC,KAAKD,MACbE,EAAU,GAAGA,QACbC,EAAuB,8BACvBC,EAAgC,sBAGpC/G,EAAOC,QAAU,SAAU+G,EAASC,EAAKC,EAAUC,EAAUC,EAAeC,GAC1E,IAAIC,EAAUJ,EAAWF,EAAQ1G,OAC7BiH,EAAIJ,EAAS7G,OACbkH,EAAUT,EAKd,YAJsBxG,IAAlB6G,IACFA,EAAgBpG,EAASoG,GACzBI,EAAUV,GAELD,EAAQrG,KAAK6G,EAAaG,GAAS,SAAUC,EAAOC,GACzD,IAAIC,EACJ,OAAQD,EAAGE,OAAO,IAChB,IAAK,IAAK,MAAO,IACjB,IAAK,IAAK,OAAOZ,EACjB,IAAK,IAAK,OAAOC,EAAIpF,MAAM,EAAGqF,GAC9B,IAAK,IAAK,OAAOD,EAAIpF,MAAMyF,GAC3B,IAAK,IACHK,EAAUP,EAAcM,EAAG7F,MAAM,GAAI,IACrC,MACF,QACE,IAAImC,GAAK0D,EACT,GAAU,IAAN1D,EAAS,OAAOyD,EACpB,GAAIzD,EAAIuD,EAAG,CACT,IAAIzE,EAAI6D,EAAM3C,EAAI,IAClB,OAAU,IAANlB,EAAgB2E,EAChB3E,GAAKyE,OAA8BhH,IAApB4G,EAASrE,EAAI,GAAmB4E,EAAGE,OAAO,GAAKT,EAASrE,EAAI,GAAK4E,EAAGE,OAAO,GACvFH,EAETE,EAAUR,EAASnD,EAAI,GAE3B,YAAmBzD,IAAZoH,EAAwB,GAAKA,O,uBCrCxC,IAAIvD,EAAc,EAAQ,QACtByD,EAAQ,EAAQ,QAChBC,EAAgB,EAAQ,QAG5B9H,EAAOC,SAAWmE,IAAgByD,GAAM,WAEtC,OAEQ,GAFD3E,OAAO6E,eAAeD,EAAc,OAAQ,IAAK,CACtDE,IAAK,WAAc,OAAO,KACzBvH,M,oCCaLT,EAAOC,QAAU,SAAgBgI,GAC/B,OAAO,SAAczE,GACnB,OAAOyE,EAASrH,MAAM,KAAM4C,M,8NCjB1B0E,EAAc,CAAC,KAAM,KAAM,KAAjC,MAEMC,EAAY,CAAC,QAAS,MAA5B,UAEA,SAASC,EAAT,KACE,OAAOF,EAAA,QAAmB,cAExB,OADAG,EAAMC,EAAS,eAAf,IAAkCC,IAClC,IAFF,IAMF,IAAMC,EAAkB,SAAAvB,GAAD,MAAc,6CAArC,IACMwB,EAAaL,EAAU,SAAS,iBAAO,CAC3CM,KAD2C,OAE3CC,QAF2C,KAG3CC,UAAWJ,MAGPK,EAAoB,SAAA5B,GAAD,MAAc,uDAAvC,IACM6B,EAAeV,EAAU,WAAW,iBAAO,CAC/CM,KAD+C,OAE/CC,QAF+C,KAG/CC,UAAWC,MAGPE,EAAyB,SAAA9B,GAAD,MAAc,iEAA5C,IACM+B,EAAoBZ,EAAU,gBAAgB,iBAAO,CACzDM,KADyD,OAEzDC,QAFyD,KAGzDC,UAAWG,MAGPE,EAAU,CACdC,MAAOhG,OAAA,KADO,GAEdiG,QAASjG,OAAA,KAFK,GAGdkG,aAAclG,OAAA,SAGVmG,EAAW,CACfH,MADe,QAEfC,QAFe,UAGfC,aAAc,iBAGhB,SAASE,EAAT,OACE,IAAIC,EAAYF,EAAhB,GACA,SAAIG,EAAJ,CAGA,KAAU,CAER,IAAMC,EAAaC,EAAA,UAAnB,IACAH,GAAa,IAAJ,OAAT,GAIF,OADAA,GAAa,IAAJ,OAAT,GACOA,EAAP,eAGF,IAAMI,EAAQ,IAAd,IAEe,qBAAW,CACxBzF,KADwB,QAExB0F,YAFwB,EAGxBvB,MAAO,8CACLwB,IAAK,CACHnB,KADG,OAEHC,QAAS,OAEXmB,MALK,QAMLC,UANK,QAOLb,MAAO,CACLR,KADK,OAELC,QAFK,KAGLC,UAAWJ,IAVR,GAAF,IAaHW,QAAS,CACPT,KADO,OAEPC,QAFO,KAGPC,UAAWC,IAhBR,GAAF,IAmBHO,aAAc,CACZV,KADY,OAEZC,QAFY,KAGZC,UAAWG,IAEVC,GAELgB,OA7BwB,SA6BlB,EA7BkB,GA6BY,IAAzB,EAAyB,EAAzB,QAAyB,EAAzB,KAAeC,EAAU,EAAVA,SAEpBC,EAAJ,GACA,IAAK,IAAL,OACEA,GAAYhK,OAAQmI,EAApB,IAEF,IAAI8B,EAAYR,EAAA,IAAhB,GAyBA,OAvBA,GAAgB,iBAGd,EACA,SAHAQ,EADc,GAId,EACElB,EAAA,YAAsB,SAAAS,GACpB,IAAMU,EAAiB/B,EAAvB,GACMkB,EAAYD,EAAgBZ,EAAMgB,EAAxC,GACA,GAAeS,EAAA,WAInBA,EAAA,SACE,aAAc9B,EADD,UAEb,aAAcA,EAFD,OAAf,iCAGYA,EAAV,OAA0BA,EAHb,OAAf,mCAIcA,EAAZ,SAA8BA,EAJjB,SAAf,yCAKoBA,EAAlB,cAAyCA,EAAMe,cALjD,IAQAO,EAAA,SApBc,GAuBTU,EACLhC,EADM,IAEN,eAAU3B,EAAM,CACd4D,YADc,MAEdC,MAAOJ,IAJX,O,kCC/HJ,IAAIjJ,EAAY,EAAQ,QACpBsJ,EAAyB,EAAQ,QAIrCxK,EAAOC,QAAU,SAAgBwK,GAC/B,IAAIxD,EAAM/G,OAAOsK,EAAuB/I,OACpCiJ,EAAS,GACT1G,EAAI9C,EAAUuJ,GAClB,GAAIzG,EAAI,GAAKA,GAAK2G,IAAU,MAAMC,WAAW,+BAC7C,KAAM5G,EAAI,GAAIA,KAAO,KAAOiD,GAAOA,GAAc,EAAJjD,IAAO0G,GAAUzD,GAC9D,OAAOyD,I,kCCXT,IAAIG,EAAgC,EAAQ,QACxCC,EAAW,EAAQ,QACnBC,EAAW,EAAQ,QACnBP,EAAyB,EAAQ,QACjCQ,EAAqB,EAAQ,QAC7BC,EAAqB,EAAQ,QAC7BhK,EAAW,EAAQ,QACnBiK,EAAiB,EAAQ,QACzBC,EAAa,EAAQ,QACrBC,EAAgB,EAAQ,QAExBC,EAAgBD,EAAcC,cAC9BC,EAAY,GAAG/E,KACfgF,EAAM3E,KAAK2E,IACXC,EAAa,WAGjBX,EAA8B,QAAS,GAAG,SAAUY,EAAOC,EAAaC,GACtE,IAAIC,EAqDJ,OAzCEA,EAV2B,KAA3B,OAAOC,MAAM,QAAQ,IAEc,GAAnC,OAAOA,MAAM,QAAS,GAAGvL,QACO,GAAhC,KAAKuL,MAAM,WAAWvL,QACU,GAAhC,IAAIuL,MAAM,YAAYvL,QAEtB,IAAIuL,MAAM,QAAQvL,OAAS,GAC3B,GAAGuL,MAAM,MAAMvL,OAGC,SAAUwL,EAAWC,GACnC,IAAIC,EAAS9L,OAAOsK,EAAuB/I,OACvCwK,OAAgB1L,IAAVwL,EAAsBP,EAAaO,IAAU,EACvD,GAAY,IAARE,EAAW,MAAO,GACtB,QAAkB1L,IAAduL,EAAyB,MAAO,CAACE,GAErC,IAAKlB,EAASgB,GACZ,OAAOJ,EAAYlL,KAAKwL,EAAQF,EAAWG,GAE7C,IAQIxE,EAAOyE,EAAWC,EARlBC,EAAS,GACTC,GAASP,EAAUQ,WAAa,IAAM,KAC7BR,EAAUS,UAAY,IAAM,KAC5BT,EAAUU,QAAU,IAAM,KAC1BV,EAAUW,OAAS,IAAM,IAClCC,EAAgB,EAEhBC,EAAgB,IAAIC,OAAOd,EAAUe,OAAQR,EAAQ,KAEzD,MAAO5E,EAAQ0D,EAAW3K,KAAKmM,EAAeX,GAAS,CAErD,GADAE,EAAYS,EAAcT,UACtBA,EAAYQ,IACdN,EAAO7F,KAAKyF,EAAOnK,MAAM6K,EAAejF,EAAMqF,QAC1CrF,EAAMnH,OAAS,GAAKmH,EAAMqF,MAAQd,EAAO1L,QAAQgL,EAAU1K,MAAMwL,EAAQ3E,EAAM5F,MAAM,IACzFsK,EAAa1E,EAAM,GAAGnH,OACtBoM,EAAgBR,EACZE,EAAO9L,QAAU2L,GAAK,MAExBU,EAAcT,YAAczE,EAAMqF,OAAOH,EAAcT,YAK7D,OAHIQ,IAAkBV,EAAO1L,QACvB6L,GAAeQ,EAAc5M,KAAK,KAAKqM,EAAO7F,KAAK,IAClD6F,EAAO7F,KAAKyF,EAAOnK,MAAM6K,IACzBN,EAAO9L,OAAS2L,EAAMG,EAAOvK,MAAM,EAAGoK,GAAOG,GAG7C,IAAIP,WAAMtL,EAAW,GAAGD,OACjB,SAAUwL,EAAWC,GACnC,YAAqBxL,IAAduL,GAAqC,IAAVC,EAAc,GAAKL,EAAYlL,KAAKiB,KAAMqK,EAAWC,IAEpEL,EAEhB,CAGL,SAAeI,EAAWC,GACxB,IAAIvK,EAAIgJ,EAAuB/I,MAC3BsL,OAAwBxM,GAAbuL,OAAyBvL,EAAYuL,EAAUL,GAC9D,YAAoBlL,IAAbwM,EACHA,EAASvM,KAAKsL,EAAWtK,EAAGuK,GAC5BH,EAAcpL,KAAKN,OAAOsB,GAAIsK,EAAWC,IAO/C,SAAUiB,EAAQjB,GAChB,IAAIkB,EAAMtB,EAAgBC,EAAeoB,EAAQvL,KAAMsK,EAAOH,IAAkBF,GAChF,GAAIuB,EAAIC,KAAM,OAAOD,EAAI7C,MAEzB,IAAI+C,EAAKpC,EAASiC,GACdI,EAAIlN,OAAOuB,MACXO,EAAIgJ,EAAmBmC,EAAIP,QAE3BS,EAAkBF,EAAGX,QACrBH,GAASc,EAAGb,WAAa,IAAM,KACtBa,EAAGZ,UAAY,IAAM,KACrBY,EAAGX,QAAU,IAAM,KACnBnB,EAAgB,IAAM,KAI/B0B,EAAW,IAAI/K,EAAEqJ,EAAgB,OAAS8B,EAAGN,OAAS,IAAMM,EAAId,GAChEJ,OAAgB1L,IAAVwL,EAAsBP,EAAaO,IAAU,EACvD,GAAY,IAARE,EAAW,MAAO,GACtB,GAAiB,IAAbmB,EAAE9M,OAAc,OAAuC,OAAhC4K,EAAe6B,EAAUK,GAAc,CAACA,GAAK,GACxE,IAAIE,EAAI,EACJC,EAAI,EACJ5L,EAAI,GACR,MAAO4L,EAAIH,EAAE9M,OAAQ,CACnByM,EAASb,UAAYb,EAAgB,EAAIkC,EACzC,IACIC,EADAC,EAAIvC,EAAe6B,EAAU1B,EAAgB+B,EAAEvL,MAAM0L,GAAKH,GAE9D,GACQ,OAANK,IACCD,EAAIjC,EAAItK,EAAS8L,EAASb,WAAab,EAAgBkC,EAAI,IAAKH,EAAE9M,WAAagN,EAEhFC,EAAItC,EAAmBmC,EAAGG,EAAGF,OACxB,CAEL,GADA1L,EAAE4E,KAAK6G,EAAEvL,MAAMyL,EAAGC,IACd5L,EAAErB,SAAW2L,EAAK,OAAOtK,EAC7B,IAAK,IAAIS,EAAI,EAAGA,GAAKqL,EAAEnN,OAAS,EAAG8B,IAEjC,GADAT,EAAE4E,KAAKkH,EAAErL,IACLT,EAAErB,SAAW2L,EAAK,OAAOtK,EAE/B4L,EAAID,EAAIE,GAIZ,OADA7L,EAAE4E,KAAK6G,EAAEvL,MAAMyL,IACR3L,MAGV0J,I,wCCrHH,E,kLASA,SAASqC,EAAT,GACE,MAAO,CAAC,MAAO,MAAO,MAAO,MAAO,OAAOC,MAAK,SAAAnE,GAAG,OAAIoE,EAAA,SAAvD,MAGF,SAASC,EAAT,GACE,MAAQ,0CAA0C9N,KAAK+N,IAAS,UAAU/N,KAAlE,IAAgF+N,EAAA,OAAxF,GAdF,YACE,mBACA,kBACA,oBACA,mBACA,kBACA,oBANF,CAAKC,MAAL,KAiBA,IAAMC,EAAQ,eAAO,EAAD,mBAIlB,QAJY,OAML,CACP9J,KADO,SAGPmE,MAAO,CACLyB,MADK,QAELmE,SAFK,QAGLC,KAHK,QAILC,MAJK,QAKLC,KAAM,CAACC,OALF,QAMLxE,IAAK,CACHnB,KADG,OAEH4F,UAFG,EAGH3F,QAAS,MAIb4F,SAAU,CACRC,OADQ,WAEN,UAEFC,iBAJQ,WAKN,OAAOC,QACLjN,KAAKkN,WAAWC,OAASnN,KAAKkN,WADhC,aAMJE,QAAS,CACPC,QADO,WAEL,IAAIC,EAAJ,GAGA,OAFItN,KAAKuN,OAAT,UAAyBD,EAAWtN,KAAKuN,OAAOrG,QAAQ,GAAGsG,KAAlC,QAElB,eAAkBxN,KAAzB,IAEFyN,QAPO,WAQL,IAAMC,EAAQ,CACZC,OAAQ3N,KADI,OAEZ4N,MAAO5N,KAFK,MAGZ+M,OAAQ/M,KAHI,OAIZ6N,MAAO7N,KAJK,MAKZ8N,OAAQ9N,KAAK8N,QAGTC,EAAe,wBAAiB,SAAAC,GAAG,OAAIN,EAA7C,MAEA,OACGK,GAAgBzB,EAAjB,IAA4C,eAActM,KAD5D,OAKFiO,eAvBO,WAwBL,MAAO,CACLpF,YADK,qBAELC,MAAO,CACL,mBAAoB9I,KADf,SAEL,eAAgBA,KAFX,KAGL,eAAgBA,KAHX,iBAIL,gBAAiBA,KAJZ,MAKL,gBAAiBA,KAAKqI,OAExB6F,MAAO,gBACL,eAAgBlO,KADX,iBAELwM,SAAUxM,KAAKgN,kBAAoBhN,KAF9B,SAGLiH,KAAMjH,KAAKgN,iBAAmB,cAHzB,GAIFhN,KAAKmO,QAEVC,GAAIpO,KAAKkN,aAGbmB,kBA1CO,WA2CL,IAAMC,EAAWtO,KAAjB,UACMuO,EAAc,iCACfvO,KADe,kBAAH,IAEfwO,MAAOF,EAAW,CAChBA,WACAG,OAFgB,EAGhBC,MAAOJ,QACLxP,IAIN,OAFAkB,KAAA,eAEA,GAEF2O,YAxDO,SAwDI,GACT1J,EAAA,uCAAkBA,EAAL,OAAoBjF,KAAK4O,cACtC5O,KAAA,aAAkBA,KAAlB,UAEF6O,eA5DO,SA4DO,KACZ,IAAMC,EAAN,GACM7J,EAAOjF,KAAb,iBAEImM,EAJwC,iBAOtC4C,EAAiB1C,EAAA,QAAvB,KACM2C,EAAiBD,IAAvB,EAEA,EAEED,EAAA,SAEA3C,EAAWE,EAAA,QAAX,GACIJ,EAAJ,KAA8BE,EAAA,KAGhClH,EAAA,YACAA,EAAA,YAEA,IAAMqJ,EAAWtO,KAAjB,UAKA,OAJA,IAAciF,EAAA,MAAa,CAAEqJ,aAE7BtO,KAAA,eAEO4I,EAAE5I,KAAKgN,iBAAmB,SAAWhN,KAApC,MAAR,IAEFiP,cAxFO,SAwFM,KACX,IAAMC,EAAqB,CACzBpG,MADyB,cAEzBoF,MAAO,CACLiB,MADK,6BAELC,QAFK,YAGLC,KAHK,MAIL,eAAe,IAIb1C,EAAO3M,KAAb,UASA,OARA,IACEkP,EAAA,MAAgB,CACdZ,SADc,EAEdG,OAFc,EAGdC,MAAO/B,IAIJ/D,EAAE5I,KAAKgN,iBAAmB,SAAzB,OAA4ChN,KAA5C,oBAAsE,CAC5E4I,EAAE,MAAOsG,EAAS,CAChBtG,EAAE,OAAQ,CACRsF,MAAO,CACLoB,EAAGjD,UAMbkD,uBAtHO,SAsHe,KAIpB,IAAMtK,EAAkB,CACtB6D,MAAO,CACL,qBAAqB,IAInB6D,EAAO3M,KAAb,UACA,IACEiF,EAAA,MAAa,CACXqJ,SADW,EAEXG,OAFW,EAGXC,MAAO/B,IAIX3M,KAAA,eAEA,IAAMwP,EAAYnD,EAAlB,UAIA,OAHApH,EAAA,MAAaoH,EAAb,MACApH,EAAA,SAAgBA,EAAhB,GAEO2D,EAAE5I,KAAKgN,iBAAmB,SAAzB,OAA4ChN,KAA5C,oBAAsE,CAC5E4I,EAAE4G,EADJ,OAMJjH,OAhLO,SAgLD,GACJ,IAAM8D,EAAOrM,KAAb,UAEA,wBAAWqM,EACLD,EAAJ,GACSpM,KAAKiP,cAAc5C,EAA1B,GAEKrM,KAAK6O,eAAexC,EAA3B,GAGKrM,KAAKuP,uBAAuBlD,EAAnC,MAIW,qBAAW,CACxB5J,KADwB,SAGxBgN,aAHwB,EAKxBtH,YALwB,EAOxBI,OAPwB,SAOlB,EAPkB,GAOK,IAAlB,EAAkB,EAAlB,KAAQC,EAAU,EAAVA,SACb8E,EADuB,GAe3B,OAXIrI,EAAJ,WACEqI,EAAWrI,EAAA,sBACTA,EAAA,SADS,WADM,SAOVA,EAAA,SAAP,mBACOA,EAAA,SAAP,WAGK2D,EAAE2D,EAAOtH,EAAMqI,EAAW,CAAH,GAA9B,O,uBC3PJ,IAAIoC,EAAU,EAAQ,QAClBhG,EAAa,EAAQ,QAIzBnL,EAAOC,QAAU,SAAUmR,EAAGhE,GAC5B,IAAIiE,EAAOD,EAAEC,KACb,GAAoB,oBAATA,EAAqB,CAC9B,IAAI3G,EAAS2G,EAAK7Q,KAAK4Q,EAAGhE,GAC1B,GAAsB,kBAAX1C,EACT,MAAM4G,UAAU,sEAElB,OAAO5G,EAGT,GAAmB,WAAfyG,EAAQC,GACV,MAAME,UAAU,+CAGlB,OAAOnG,EAAW3K,KAAK4Q,EAAGhE,K,uBCnB5B,IAAImE,EAAS,EAAQ,QACjBC,EAAe,EAAQ,QACvBtL,EAAU,EAAQ,QAClBuL,EAA8B,EAAQ,QAE1C,IAAK,IAAIC,KAAmBF,EAAc,CACxC,IAAIG,EAAaJ,EAAOG,GACpBE,EAAsBD,GAAcA,EAAWhP,UAEnD,GAAIiP,GAAuBA,EAAoB1L,UAAYA,EAAS,IAClEuL,EAA4BG,EAAqB,UAAW1L,GAC5D,MAAO5C,GACPsO,EAAoB1L,QAAUA,K,oCCXlC,IAAI2L,EAAW,EAAQ,QAAgC3L,QACnD4L,EAAsB,EAAQ,QAE9BC,EAAgBD,EAAoB,WAIxC9R,EAAOC,QAAW8R,EAGd,GAAG7L,QAH2B,SAAiB8L,GACjD,OAAOH,EAASpQ,KAAMuQ,EAAYnR,UAAUP,OAAS,EAAIO,UAAU,QAAKN,K,oCCR1E,IAAIO,EAAI,EAAQ,QACZmR,EAAa,EAAQ,QACrBC,EAAyB,EAAQ,QAIrCpR,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,OAAQD,EAAuB,WAAa,CAC7EE,OAAQ,SAAgBlO,GACtB,OAAO+N,EAAWxQ,KAAM,IAAK,OAAQyC,O,qBCTzClE,EAAOC,QAAU,SAAUoD,EAAIgP,EAAanO,GAC1C,KAAMb,aAAcgP,GAClB,MAAMf,UAAU,cAAgBpN,EAAOA,EAAO,IAAM,IAAM,cAC1D,OAAOb,I,uBCHX,IAAIiP,EAAa,EAAQ,QAEzBtS,EAAOC,QAAUqS,EAAW,WAAY,oB,qBCFxCtS,EAAOC,QAAU,SAAUoD,GACzB,GAAiB,mBAANA,EACT,MAAMiO,UAAUpR,OAAOmD,GAAM,sBAC7B,OAAOA,I,uBCHX,IAAIxD,EAAkB,EAAQ,QAE1B0S,EAAW1S,EAAgB,YAC3B2S,GAAe,EAEnB,IACE,IAAIC,EAAS,EACTC,EAAqB,CACvBC,KAAM,WACJ,MAAO,CAAEzF,OAAQuF,MAEnB,OAAU,WACRD,GAAe,IAGnBE,EAAmBH,GAAY,WAC7B,OAAO9Q,MAGTkC,MAAMQ,KAAKuO,GAAoB,WAAc,MAAM,KACnD,MAAOpP,IAETtD,EAAOC,QAAU,SAAUoR,EAAMuB,GAC/B,IAAKA,IAAiBJ,EAAc,OAAO,EAC3C,IAAIK,GAAoB,EACxB,IACE,IAAIC,EAAS,GACbA,EAAOP,GAAY,WACjB,MAAO,CACLI,KAAM,WACJ,MAAO,CAAEzF,KAAM2F,GAAoB,MAIzCxB,EAAKyB,GACL,MAAOxP,IACT,OAAOuP,I,uBCpCT,IAAIE,EAAY,EAAQ,QAExB/S,EAAOC,QAAU,qCAAqCF,KAAKgT,I,oCCA3D/S,EAAOC,QAAU,SAAcG,EAAI4S,GACjC,OAAO,WAEL,IADA,IAAI9Q,EAAO,IAAIyB,MAAM9C,UAAUP,QACtB8B,EAAI,EAAGA,EAAIF,EAAK5B,OAAQ8B,IAC/BF,EAAKE,GAAKvB,UAAUuB,GAEtB,OAAOhC,EAAGQ,MAAMoS,EAAS9Q,M,qBCN7BlC,EAAOC,QAAU,SAAUoD,GACzB,QAAU9C,GAAN8C,EAAiB,MAAMiO,UAAU,wBAA0BjO,GAC/D,OAAOA,I,uBCJT,IAAIwE,EAAQ,EAAQ,QAChBhI,EAAkB,EAAQ,QAC1BoT,EAAa,EAAQ,QAErBC,EAAUrT,EAAgB,WAE9BG,EAAOC,QAAU,SAAUkT,GAIzB,OAAOF,GAAc,KAAOpL,GAAM,WAChC,IAAIuL,EAAQ,GACRnP,EAAcmP,EAAMnP,YAAc,GAItC,OAHAA,EAAYiP,GAAW,WACrB,MAAO,CAAEG,IAAK,IAE2B,IAApCD,EAAMD,GAAazE,SAAS2E,S,8CChBvC,IAAItI,EAAW,EAAQ,QACnBuI,EAAwB,EAAQ,QAChCrS,EAAW,EAAQ,QACnBsB,EAAO,EAAQ,QACfgR,EAAoB,EAAQ,QAC5BC,EAAgB,EAAQ,QAExBC,EAAS,SAAUC,EAAShJ,GAC9BjJ,KAAKiS,QAAUA,EACfjS,KAAKiJ,OAASA,GAGhB1K,EAAOC,QAAU,SAAU0T,EAAUC,EAAiBC,GACpD,IAKIC,EAAUC,EAAQjH,EAAOxM,EAAQoK,EAAQiI,EAAMqB,EAL/C3T,EAAOwT,GAAWA,EAAQxT,KAC1B4T,KAAgBJ,IAAWA,EAAQI,YACnCC,KAAiBL,IAAWA,EAAQK,aACpCC,KAAiBN,IAAWA,EAAQM,aACpC/T,EAAKmC,EAAKqR,EAAiBvT,EAAM,EAAI4T,EAAaE,GAGlDC,EAAO,SAAUC,GAEnB,OADIP,GAAUN,EAAcM,GACrB,IAAIL,GAAO,EAAMY,IAGtBC,EAAS,SAAUlK,GACrB,OAAI6J,GACFlJ,EAASX,GACF+J,EAAc/T,EAAGgK,EAAM,GAAIA,EAAM,GAAIgK,GAAQhU,EAAGgK,EAAM,GAAIA,EAAM,KAChE+J,EAAc/T,EAAGgK,EAAOgK,GAAQhU,EAAGgK,IAG9C,GAAI8J,EACFJ,EAAWH,MACN,CAEL,GADAI,EAASR,EAAkBI,GACN,mBAAVI,EAAsB,MAAMzC,UAAU,0BAEjD,GAAIgC,EAAsBS,GAAS,CACjC,IAAKjH,EAAQ,EAAGxM,EAASW,EAAS0S,EAASrT,QAASA,EAASwM,EAAOA,IAElE,GADApC,EAAS4J,EAAOX,EAAS7G,IACrBpC,GAAUA,aAAkB+I,EAAQ,OAAO/I,EAC/C,OAAO,IAAI+I,GAAO,GAEtBK,EAAWC,EAAOvT,KAAKmT,GAGzBhB,EAAOmB,EAASnB,KAChB,QAASqB,EAAOrB,EAAKnS,KAAKsT,IAAW5G,KAAM,CACzC,IACExC,EAAS4J,EAAON,EAAK5J,OACrB,MAAO9G,GAEP,MADAkQ,EAAcM,GACRxQ,EAER,GAAqB,iBAAVoH,GAAsBA,GAAUA,aAAkB+I,EAAQ,OAAO/I,EAC5E,OAAO,IAAI+I,GAAO,K,uBCxDtB,IAAIvS,EAAY,EAAQ,QAEpBqT,EAAM3N,KAAK2N,IACXhJ,EAAM3E,KAAK2E,IAKfvL,EAAOC,QAAU,SAAU6M,EAAOxM,GAChC,IAAIkU,EAAUtT,EAAU4L,GACxB,OAAO0H,EAAU,EAAID,EAAIC,EAAUlU,EAAQ,GAAKiL,EAAIiJ,EAASlU,K,uBCV/D,IAAIiR,EAAS,EAAQ,QACjB5M,EAA2B,EAAQ,QAAmD7B,EACtF2O,EAA8B,EAAQ,QACtCgD,EAAW,EAAQ,QACnBC,EAAY,EAAQ,QACpBC,EAA4B,EAAQ,QACpCC,EAAW,EAAQ,QAgBvB5U,EAAOC,QAAU,SAAU4T,EAAShH,GAClC,IAGIgI,EAAQzT,EAAQqO,EAAKqF,EAAgBC,EAAgBC,EAHrDC,EAASpB,EAAQzS,OACjB8T,EAASrB,EAAQtC,OACjB4D,EAAStB,EAAQ9O,KASrB,GANE3D,EADE8T,EACO3D,EACA4D,EACA5D,EAAO0D,IAAWP,EAAUO,EAAQ,KAEnC1D,EAAO0D,IAAW,IAAItS,UAE9BvB,EAAQ,IAAKqO,KAAO5C,EAAQ,CAQ9B,GAPAkI,EAAiBlI,EAAO4C,GACpBoE,EAAQuB,aACVJ,EAAarQ,EAAyBvD,EAAQqO,GAC9CqF,EAAiBE,GAAcA,EAAW5K,OACrC0K,EAAiB1T,EAAOqO,GAC/BoF,EAASD,EAASM,EAASzF,EAAMwF,GAAUE,EAAS,IAAM,KAAO1F,EAAKoE,EAAQ1B,SAEzE0C,QAA6BtU,IAAnBuU,EAA8B,CAC3C,UAAWC,WAA0BD,EAAgB,SACrDH,EAA0BI,EAAgBD,IAGxCjB,EAAQwB,MAASP,GAAkBA,EAAeO,OACpD5D,EAA4BsD,EAAgB,QAAQ,GAGtDN,EAASrT,EAAQqO,EAAKsF,EAAgBlB,M,uBCnD1C,IAAIyB,EAAqB,EAAQ,QAC7BC,EAAc,EAAQ,QAEtBC,EAAaD,EAAY7S,OAAO,SAAU,aAK9CzC,EAAQ6C,EAAII,OAAOC,qBAAuB,SAA6B3B,GACrE,OAAO8T,EAAmB9T,EAAGgU,K,mCCT/B,YAEA,IAAIvQ,EAAQ,EAAQ,QAChBwQ,EAAsB,EAAQ,QAE9BC,EAAuB,CACzB,eAAgB,qCAGlB,SAASC,EAAsBC,EAASxL,IACjCnF,EAAM4Q,YAAYD,IAAY3Q,EAAM4Q,YAAYD,EAAQ,mBAC3DA,EAAQ,gBAAkBxL,GAI9B,SAAS0L,IACP,IAAIC,EAQJ,OAP8B,qBAAnBC,gBAGmB,qBAAZC,KADhBF,EAAU,EAAQ,SAKbA,EAGT,IAAI/Q,EAAW,CACb+Q,QAASD,IAETI,iBAAkB,CAAC,SAA0BxP,EAAMkP,GAEjD,OADAH,EAAoBG,EAAS,gBACzB3Q,EAAMkR,WAAWzP,IACnBzB,EAAMmR,cAAc1P,IACpBzB,EAAMoR,SAAS3P,IACfzB,EAAMqR,SAAS5P,IACfzB,EAAMsR,OAAO7P,IACbzB,EAAMuR,OAAO9P,GAENA,EAELzB,EAAMwR,kBAAkB/P,GACnBA,EAAKgQ,OAEVzR,EAAM0R,kBAAkBjQ,IAC1BiP,EAAsBC,EAAS,mDACxBlP,EAAK3D,YAEVkC,EAAMrD,SAAS8E,IACjBiP,EAAsBC,EAAS,kCACxBgB,KAAKC,UAAUnQ,IAEjBA,IAGToQ,kBAAmB,CAAC,SAA2BpQ,GAE7C,GAAoB,kBAATA,EACT,IACEA,EAAOkQ,KAAKG,MAAMrQ,GAClB,MAAO8G,IAEX,OAAO9G,IAOTsQ,QAAS,EAETC,eAAgB,aAChBC,eAAgB,eAEhBC,kBAAmB,EAEnBC,eAAgB,SAAwBC,GACtC,OAAOA,GAAU,KAAOA,EAAS,KAIrC,QAAmB,CACjBC,OAAQ,CACN,OAAU,uCAIdrS,EAAMiB,QAAQ,CAAC,SAAU,MAAO,SAAS,SAA6BN,GACpEZ,EAAS4Q,QAAQhQ,GAAU,MAG7BX,EAAMiB,QAAQ,CAAC,OAAQ,MAAO,UAAU,SAA+BN,GACrEZ,EAAS4Q,QAAQhQ,GAAUX,EAAMS,MAAMgQ,MAGzC1V,EAAOC,QAAU+E,I,gGCvFF,qBAAW,CACxBd,KADwB,aAGxBmE,MAAO,CACL6H,OAAQ,CAAC7B,OADJ,QAELkJ,UAAW,CAAClJ,OAFP,QAGLmJ,SAAU,CAACnJ,OAHN,QAILoJ,UAAW,CAACpJ,OAJP,QAKLqJ,SAAU,CAACrJ,OALN,QAML8B,MAAO,CAAC9B,OAAQnO,SAGlBqO,SAAU,CACRoJ,iBADQ,WAEN,IAAMC,EAAN,GAEM1H,EAAS,eAAczO,KAA7B,QACMgW,EAAY,eAAchW,KAAhC,WACMiW,EAAW,eAAcjW,KAA/B,UACM8V,EAAY,eAAc9V,KAAhC,WACM+V,EAAW,eAAc/V,KAA/B,UACM0O,EAAQ,eAAc1O,KAA5B,OASA,OAPA,IAAYmW,EAAA,UACZ,IAAeA,EAAA,aACf,IAAcA,EAAA,YACd,IAAeA,EAAA,aACf,IAAcA,EAAA,YACd,IAAWA,EAAA,SAEX,O,kCCrCN,IAAI9W,EAAI,EAAQ,QACZ+W,EAAa,EAAQ,QACrBrN,EAAyB,EAAQ,QACjCsN,EAAuB,EAAQ,QAInChX,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,QAAS2F,EAAqB,aAAe,CAC9EC,SAAU,SAAkBC,GAC1B,SAAU9X,OAAOsK,EAAuB/I,OACrCwW,QAAQJ,EAAWG,GAAenX,UAAUP,OAAS,EAAIO,UAAU,QAAKN,O,6DCV/E,IAAIkU,EAAW,EAAQ,QACnB1J,EAAW,EAAQ,QACnBlD,EAAQ,EAAQ,QAChBwE,EAAQ,EAAQ,QAEhB6L,EAAY,WACZC,EAAkBvL,OAAOjK,UACzByV,EAAiBD,EAAgBD,GAEjCG,EAAcxQ,GAAM,WAAc,MAA2D,QAApDuQ,EAAe5X,KAAK,CAAEqM,OAAQ,IAAKR,MAAO,SAEnFiM,EAAiBF,EAAelU,MAAQgU,GAIxCG,GAAeC,IACjB7D,EAAS7H,OAAOjK,UAAWuV,GAAW,WACpC,IAAI9G,EAAIrG,EAAStJ,MACb6L,EAAIpN,OAAOkR,EAAEvE,QACb0L,EAAKnH,EAAE/E,MACPvJ,EAAI5C,YAAcK,IAAPgY,GAAoBnH,aAAaxE,UAAY,UAAWuL,GAAmB9L,EAAM7L,KAAK4Q,GAAKmH,GAC1G,MAAO,IAAMjL,EAAI,IAAMxK,IACtB,CAAE0V,QAAQ,K,kCCtBf,IAAIlG,EAAa,EAAQ,QACrBmG,EAAuB,EAAQ,QAC/B5Y,EAAkB,EAAQ,QAC1BuE,EAAc,EAAQ,QAEtB8O,EAAUrT,EAAgB,WAE9BG,EAAOC,QAAU,SAAUyY,GACzB,IAAIrG,EAAcC,EAAWoG,GACzB3Q,EAAiB0Q,EAAqB3V,EAEtCsB,GAAeiO,IAAgBA,EAAYa,IAC7CnL,EAAesK,EAAaa,EAAS,CACnCyF,cAAc,EACd3Q,IAAK,WAAc,OAAOvG,U,kCCTjB,SAASmX,EACtBC,EACA7O,EACA8O,EACAC,EACAC,EACAC,EACAC,EACAC,GAGA,IAqBIC,EArBAvF,EAAmC,oBAAlBgF,EACjBA,EAAchF,QACdgF,EAsDJ,GAnDI7O,IACF6J,EAAQ7J,OAASA,EACjB6J,EAAQiF,gBAAkBA,EAC1BjF,EAAQwF,WAAY,GAIlBN,IACFlF,EAAQjK,YAAa,GAInBqP,IACFpF,EAAQyF,SAAW,UAAYL,GAI7BC,GACFE,EAAO,SAAUG,GAEfA,EACEA,GACC9X,KAAK+X,QAAU/X,KAAK+X,OAAOC,YAC3BhY,KAAKiY,QAAUjY,KAAKiY,OAAOF,QAAU/X,KAAKiY,OAAOF,OAAOC,WAEtDF,GAA0C,qBAAxBI,sBACrBJ,EAAUI,qBAGRX,GACFA,EAAaxY,KAAKiB,KAAM8X,GAGtBA,GAAWA,EAAQK,uBACrBL,EAAQK,sBAAsBC,IAAIX,IAKtCrF,EAAQiG,aAAeV,GACdJ,IACTI,EAAOD,EACH,WACAH,EAAaxY,KACXiB,MACCoS,EAAQjK,WAAanI,KAAKiY,OAASjY,MAAMsY,MAAMC,SAASC,aAG3DjB,GAGFI,EACF,GAAIvF,EAAQjK,WAAY,CAGtBiK,EAAQqG,cAAgBd,EAExB,IAAIe,EAAiBtG,EAAQ7J,OAC7B6J,EAAQ7J,OAAS,SAAmCK,EAAGkP,GAErD,OADAH,EAAK5Y,KAAK+Y,GACHY,EAAe9P,EAAGkP,QAEtB,CAEL,IAAIa,EAAWvG,EAAQwG,aACvBxG,EAAQwG,aAAeD,EACnB,GAAG1X,OAAO0X,EAAUhB,GACpB,CAACA,GAIT,MAAO,CACLnZ,QAAS4Y,EACThF,QAASA,GA/Fb,mC,uBCAA,IAAI9I,EAAW,EAAQ,QAEvB/K,EAAOC,QAAU,SAAU6T,GACzB,IAAIwG,EAAexG,EAAS,UAC5B,QAAqBvT,IAAjB+Z,EACF,OAAOvP,EAASuP,EAAa9Z,KAAKsT,IAAW1J,Q,qCCLjD;;;;;;AAOA,IAAImQ,EAAcrX,OAAOsX,OAAO,IAIhC,SAASC,EAASC,GAChB,YAAana,IAANma,GAAyB,OAANA,EAG5B,SAASC,EAAOD,GACd,YAAana,IAANma,GAAyB,OAANA,EAG5B,SAASE,EAAQF,GACf,OAAa,IAANA,EAGT,SAASG,EAASH,GAChB,OAAa,IAANA,EAMT,SAASI,EAAa1Q,GACpB,MACmB,kBAAVA,GACU,kBAAVA,GAEU,kBAAVA,GACU,mBAAVA,EASX,SAASxI,EAAUmZ,GACjB,OAAe,OAARA,GAA+B,kBAARA,EAMhC,IAAIC,EAAY9X,OAAOP,UAAUI,SAUjC,SAASkY,EAAeF,GACtB,MAA+B,oBAAxBC,EAAUxa,KAAKua,GAGxB,SAASjQ,EAAU4P,GACjB,MAA6B,oBAAtBM,EAAUxa,KAAKka,GAMxB,SAASQ,EAAmB1R,GAC1B,IAAIxF,EAAImX,WAAWjb,OAAOsJ,IAC1B,OAAOxF,GAAK,GAAK4C,KAAKD,MAAM3C,KAAOA,GAAKoX,SAAS5R,GAGnD,SAAS6R,EAAW7R,GAClB,OACEmR,EAAMnR,IACc,oBAAbA,EAAIhD,MACU,oBAAdgD,EAAI8R,MAOf,SAASvY,EAAUyG,GACjB,OAAc,MAAPA,EACH,GACA7F,MAAM4X,QAAQ/R,IAASyR,EAAczR,IAAQA,EAAIzG,WAAaiY,EAC5DpE,KAAKC,UAAUrN,EAAK,KAAM,GAC1BtJ,OAAOsJ,GAOf,SAASgS,EAAUhS,GACjB,IAAIxF,EAAImX,WAAW3R,GACnB,OAAOiS,MAAMzX,GAAKwF,EAAMxF,EAO1B,SAAS0X,EACPzU,EACA0U,GAIA,IAFA,IAAIC,EAAM1Y,OAAO2Y,OAAO,MACpB1Z,EAAO8E,EAAI4E,MAAM,KACZzJ,EAAI,EAAGA,EAAID,EAAK7B,OAAQ8B,IAC/BwZ,EAAIzZ,EAAKC,KAAM,EAEjB,OAAOuZ,EACH,SAAUnS,GAAO,OAAOoS,EAAIpS,EAAI3D,gBAChC,SAAU2D,GAAO,OAAOoS,EAAIpS,IAMfkS,EAAQ,kBAAkB,GAA7C,IAKII,EAAsBJ,EAAQ,8BAKlC,SAASK,EAAQvY,EAAKwY,GACpB,GAAIxY,EAAIlD,OAAQ,CACd,IAAIwM,EAAQtJ,EAAIyU,QAAQ+D,GACxB,GAAIlP,GAAS,EACX,OAAOtJ,EAAIyY,OAAOnP,EAAO,IAQ/B,IAAIoP,EAAiBhZ,OAAOP,UAAUuZ,eACtC,SAASC,EAAQpB,EAAKtL,GACpB,OAAOyM,EAAe1b,KAAKua,EAAKtL,GAMlC,SAAS2M,EAAQhc,GACf,IAAIuJ,EAAQzG,OAAO2Y,OAAO,MAC1B,OAAO,SAAoB5U,GACzB,IAAIoV,EAAM1S,EAAM1C,GAChB,OAAOoV,IAAQ1S,EAAM1C,GAAO7G,EAAG6G,KAOnC,IAAIqV,EAAa,SACbC,EAAWH,GAAO,SAAUnV,GAC9B,OAAOA,EAAIJ,QAAQyV,GAAY,SAAUE,EAAG7b,GAAK,OAAOA,EAAIA,EAAE8b,cAAgB,SAM5EC,EAAaN,GAAO,SAAUnV,GAChC,OAAOA,EAAIW,OAAO,GAAG6U,cAAgBxV,EAAIpF,MAAM,MAM7C8a,EAAc,aACdC,EAAYR,GAAO,SAAUnV,GAC/B,OAAOA,EAAIJ,QAAQ8V,EAAa,OAAO9W,iBAYzC,SAASgX,EAAczc,EAAI0c,GACzB,SAASC,EAAStc,GAChB,IAAIuc,EAAInc,UAAUP,OAClB,OAAO0c,EACHA,EAAI,EACF5c,EAAGQ,MAAMkc,EAAKjc,WACdT,EAAGI,KAAKsc,EAAKrc,GACfL,EAAGI,KAAKsc,GAId,OADAC,EAAQE,QAAU7c,EAAGE,OACdyc,EAGT,SAASG,EAAY9c,EAAI0c,GACvB,OAAO1c,EAAGmC,KAAKua,GAGjB,IAAIva,EAAOF,SAASM,UAAUJ,KAC1B2a,EACAL,EAKJ,SAASM,EAAShb,EAAMib,GACtBA,EAAQA,GAAS,EACjB,IAAIhb,EAAID,EAAK7B,OAAS8c,EAClBC,EAAM,IAAI1Z,MAAMvB,GACpB,MAAOA,IACLib,EAAIjb,GAAKD,EAAKC,EAAIgb,GAEpB,OAAOC,EAMT,SAASC,EAAQC,EAAIC,GACnB,IAAK,IAAI/N,KAAO+N,EACdD,EAAG9N,GAAO+N,EAAM/N,GAElB,OAAO8N,EAMT,SAASvc,EAAUwC,GAEjB,IADA,IAAIyJ,EAAM,GACD7K,EAAI,EAAGA,EAAIoB,EAAIlD,OAAQ8B,IAC1BoB,EAAIpB,IACNkb,EAAOrQ,EAAKzJ,EAAIpB,IAGpB,OAAO6K,EAUT,SAASwQ,EAAMhd,EAAGC,EAAGC,IAKrB,IAAI+c,EAAK,SAAUjd,EAAGC,EAAGC,GAAK,OAAO,GAOjCgd,EAAW,SAAUnB,GAAK,OAAOA,GAMrC,SAASoB,EAAYnd,EAAGC,GACtB,GAAID,IAAMC,EAAK,OAAO,EACtB,IAAImd,EAAYjc,EAASnB,GACrBqd,EAAYlc,EAASlB,GACzB,IAAImd,IAAaC,EAwBV,OAAKD,IAAcC,GACjB5d,OAAOO,KAAOP,OAAOQ,GAxB5B,IACE,IAAIqd,EAAWpa,MAAM4X,QAAQ9a,GACzBud,EAAWra,MAAM4X,QAAQ7a,GAC7B,GAAIqd,GAAYC,EACd,OAAOvd,EAAEH,SAAWI,EAAEJ,QAAUG,EAAEwd,OAAM,SAAUzQ,EAAGpL,GACnD,OAAOwb,EAAWpQ,EAAG9M,EAAE0B,OAEpB,GAAI3B,aAAayd,MAAQxd,aAAawd,KAC3C,OAAOzd,EAAE0d,YAAczd,EAAEyd,UACpB,GAAKJ,GAAaC,EAQvB,OAAO,EAPP,IAAII,EAAQlb,OAAOmb,KAAK5d,GACpB6d,EAAQpb,OAAOmb,KAAK3d,GACxB,OAAO0d,EAAM9d,SAAWge,EAAMhe,QAAU8d,EAAMH,OAAM,SAAUxO,GAC5D,OAAOmO,EAAWnd,EAAEgP,GAAM/O,EAAE+O,OAMhC,MAAOjC,GAEP,OAAO,GAcb,SAAS+Q,EAAc/a,EAAKgG,GAC1B,IAAK,IAAIpH,EAAI,EAAGA,EAAIoB,EAAIlD,OAAQ8B,IAC9B,GAAIwb,EAAWpa,EAAIpB,GAAIoH,GAAQ,OAAOpH,EAExC,OAAQ,EAMV,SAASoc,EAAMpe,GACb,IAAIqS,GAAS,EACb,OAAO,WACAA,IACHA,GAAS,EACTrS,EAAGQ,MAAMa,KAAMZ,aAKrB,IAAI4d,EAAW,uBAEXC,EAAc,CAChB,YACA,YACA,UAGEC,EAAkB,CACpB,eACA,UACA,cACA,UACA,eACA,UACA,gBACA,YACA,YACA,cACA,gBACA,kBAOElZ,EAAS,CAKXmZ,sBAAuB1b,OAAO2Y,OAAO,MAKrCgD,QAAQ,EAKRC,eAAe,EAKfC,UAAU,EAKVC,aAAa,EAKbC,aAAc,KAKdC,YAAa,KAKbC,gBAAiB,GAMjBC,SAAUlc,OAAO2Y,OAAO,MAMxBwD,cAAe3B,EAMf4B,eAAgB5B,EAMhB6B,iBAAkB7B,EAKlB8B,gBAAiB/B,EAKjBgC,qBAAsB9B,EAMtB+B,YAAahC,EAMbiC,OAAO,EAKPC,gBAAiBjB,GAUfkB,EAAgB,8JAKpB,SAASC,EAAY7Y,GACnB,IAAItG,GAAKsG,EAAM,IAAI8Y,WAAW,GAC9B,OAAa,KAANpf,GAAoB,KAANA,EAMvB,SAAS4H,EAAKwS,EAAKtL,EAAKjG,EAAKwW,GAC3B9c,OAAO6E,eAAegT,EAAKtL,EAAK,CAC9BrF,MAAOZ,EACPwW,aAAcA,EACdC,UAAU,EACVtH,cAAc,IAOlB,IAAIuH,EAAS,IAAItT,OAAQ,KAAQiT,EAAoB,OAAI,WACzD,SAASM,EAAWC,GAClB,IAAIF,EAAOngB,KAAKqgB,GAAhB,CAGA,IAAIC,EAAWD,EAAKvU,MAAM,KAC1B,OAAO,SAAUkP,GACf,IAAK,IAAI3Y,EAAI,EAAGA,EAAIie,EAAS/f,OAAQ8B,IAAK,CACxC,IAAK2Y,EAAO,OACZA,EAAMA,EAAIsF,EAASje,IAErB,OAAO2Y,IAOX,IAmCIuF,EAnCAC,EAAW,aAAe,GAG1BC,EAA8B,qBAAXvd,OACnBwd,EAAkC,qBAAlBC,iBAAmCA,cAAcC,SACjEC,EAAeH,GAAUC,cAAcC,SAAS9a,cAChDgb,EAAKL,GAAavd,OAAO6d,UAAU/N,UAAUlN,cAC7Ckb,GAAOF,GAAM,eAAe9gB,KAAK8gB,GACjCG,GAAQH,GAAMA,EAAG5I,QAAQ,YAAc,EACvCgJ,GAASJ,GAAMA,EAAG5I,QAAQ,SAAW,EAErCiJ,IADaL,GAAMA,EAAG5I,QAAQ,WACrB4I,GAAM,uBAAuB9gB,KAAK8gB,IAA0B,QAAjBD,GAGpDO,IAFWN,GAAM,cAAc9gB,KAAK8gB,GACtBA,GAAM,YAAY9gB,KAAK8gB,GAC9BA,GAAMA,EAAGpZ,MAAM,mBAGtB2Z,GAAc,GAAKC,MAEnBC,IAAkB,EACtB,GAAId,EACF,IACE,IAAIe,GAAO,GACXre,OAAO6E,eAAewZ,GAAM,UAAW,CACrCvZ,IAAK,WAEHsZ,IAAkB,KAGtBre,OAAOue,iBAAiB,eAAgB,KAAMD,IAC9C,MAAO/T,KAMX,IAAIiU,GAAoB,WAWtB,YAVkBlhB,IAAd+f,IAOAA,GALGE,IAAcC,GAA4B,qBAAXlP,IAGtBA,EAAO,YAAgD,WAAlCA,EAAO,WAAWmQ,IAAIC,UAKpDrB,GAILvB,GAAWyB,GAAavd,OAAO2e,6BAGnC,SAASC,GAAUC,GACjB,MAAuB,oBAATA,GAAuB,cAAc/hB,KAAK+hB,EAAK/e,YAG/D,IAIIgf,GAJAC,GACgB,qBAAXC,QAA0BJ,GAASI,SACvB,qBAAZC,SAA2BL,GAASK,QAAQC,SAMnDJ,GAFiB,qBAARK,KAAuBP,GAASO,KAElCA,IAGc,WACnB,SAASA,IACP3gB,KAAK4gB,IAAMnf,OAAO2Y,OAAO,MAY3B,OAVAuG,EAAIzf,UAAU6B,IAAM,SAAciL,GAChC,OAAyB,IAAlBhO,KAAK4gB,IAAI5S,IAElB2S,EAAIzf,UAAUkX,IAAM,SAAcpK,GAChChO,KAAK4gB,IAAI5S,IAAO,GAElB2S,EAAIzf,UAAU2f,MAAQ,WACpB7gB,KAAK4gB,IAAMnf,OAAO2Y,OAAO,OAGpBuG,EAdW,GAoBtB,IAAIG,GAAO9E,EA8FP+E,GAAM,EAMNC,GAAM,WACRhhB,KAAKihB,GAAKF,KACV/gB,KAAKkhB,KAAO,IAGdF,GAAI9f,UAAUigB,OAAS,SAAiBC,GACtCphB,KAAKkhB,KAAKpc,KAAKsc,IAGjBJ,GAAI9f,UAAUmgB,UAAY,SAAoBD,GAC5C9G,EAAOta,KAAKkhB,KAAME,IAGpBJ,GAAI9f,UAAUogB,OAAS,WACjBN,GAAIrhB,QACNqhB,GAAIrhB,OAAO4hB,OAAOvhB,OAItBghB,GAAI9f,UAAUsgB,OAAS,WAErB,IAAIN,EAAOlhB,KAAKkhB,KAAK9gB,QAOrB,IAAK,IAAIO,EAAI,EAAG4a,EAAI2F,EAAKriB,OAAQ8B,EAAI4a,EAAG5a,IACtCugB,EAAKvgB,GAAG8gB,UAOZT,GAAIrhB,OAAS,KACb,IAAI+hB,GAAc,GAElB,SAASC,GAAYhiB,GACnB+hB,GAAY5c,KAAKnF,GACjBqhB,GAAIrhB,OAASA,EAGf,SAASiiB,KACPF,GAAYG,MACZb,GAAIrhB,OAAS+hB,GAAYA,GAAY7iB,OAAS,GAKhD,IAAIijB,GAAQ,SACV1Z,EACAnD,EACAuD,EACAgF,EACAuU,EACAjK,EACAkK,EACAC,GAEAjiB,KAAKoI,IAAMA,EACXpI,KAAKiF,KAAOA,EACZjF,KAAKwI,SAAWA,EAChBxI,KAAKwN,KAAOA,EACZxN,KAAK+hB,IAAMA,EACX/hB,KAAKkiB,QAAKpjB,EACVkB,KAAK8X,QAAUA,EACf9X,KAAKmiB,eAAYrjB,EACjBkB,KAAKoiB,eAAYtjB,EACjBkB,KAAKqiB,eAAYvjB,EACjBkB,KAAKgO,IAAM/I,GAAQA,EAAK+I,IACxBhO,KAAKgiB,iBAAmBA,EACxBhiB,KAAKsiB,uBAAoBxjB,EACzBkB,KAAKiY,YAASnZ,EACdkB,KAAKuiB,KAAM,EACXviB,KAAKwiB,UAAW,EAChBxiB,KAAKyiB,cAAe,EACpBziB,KAAK0iB,WAAY,EACjB1iB,KAAK2iB,UAAW,EAChB3iB,KAAK4iB,QAAS,EACd5iB,KAAKiiB,aAAeA,EACpBjiB,KAAK6iB,eAAY/jB,EACjBkB,KAAK8iB,oBAAqB,GAGxBC,GAAqB,CAAEC,MAAO,CAAE9L,cAAc,IAIlD6L,GAAmBC,MAAMzc,IAAM,WAC7B,OAAOvG,KAAKsiB,mBAGd7gB,OAAOwhB,iBAAkBnB,GAAM5gB,UAAW6hB,IAE1C,IAAIG,GAAmB,SAAU1V,QACjB,IAATA,IAAkBA,EAAO,IAE9B,IAAI2V,EAAO,IAAIrB,GAGf,OAFAqB,EAAK3V,KAAOA,EACZ2V,EAAKT,WAAY,EACVS,GAGT,SAASC,GAAiBrb,GACxB,OAAO,IAAI+Z,QAAMhjB,OAAWA,OAAWA,EAAWL,OAAOsJ,IAO3D,SAASsb,GAAYC,GACnB,IAAIC,EAAS,IAAIzB,GACfwB,EAAMlb,IACNkb,EAAMre,KAINqe,EAAM9a,UAAY8a,EAAM9a,SAASpI,QACjCkjB,EAAM9V,KACN8V,EAAMvB,IACNuB,EAAMxL,QACNwL,EAAMtB,iBACNsB,EAAMrB,cAWR,OATAsB,EAAOrB,GAAKoB,EAAMpB,GAClBqB,EAAOf,SAAWc,EAAMd,SACxBe,EAAOvV,IAAMsV,EAAMtV,IACnBuV,EAAOb,UAAYY,EAAMZ,UACzBa,EAAOpB,UAAYmB,EAAMnB,UACzBoB,EAAOnB,UAAYkB,EAAMlB,UACzBmB,EAAOlB,UAAYiB,EAAMjB,UACzBkB,EAAOV,UAAYS,EAAMT,UACzBU,EAAOZ,UAAW,EACXY,EAQT,IAAIC,GAAathB,MAAMhB,UACnBuiB,GAAehiB,OAAO2Y,OAAOoJ,IAE7BE,GAAiB,CACnB,OACA,MACA,QACA,UACA,SACA,OACA,WAMFA,GAAejf,SAAQ,SAAUN,GAE/B,IAAIwf,EAAWH,GAAWrf,GAC1B2C,EAAI2c,GAActf,GAAQ,WACxB,IAAI1D,EAAO,GAAIuB,EAAM5C,UAAUP,OAC/B,MAAQmD,IAAQvB,EAAMuB,GAAQ5C,UAAW4C,GAEzC,IAEI4hB,EAFA3a,EAAS0a,EAASxkB,MAAMa,KAAMS,GAC9BojB,EAAK7jB,KAAK8jB,OAEd,OAAQ3f,GACN,IAAK,OACL,IAAK,UACHyf,EAAWnjB,EACX,MACF,IAAK,SACHmjB,EAAWnjB,EAAKL,MAAM,GACtB,MAKJ,OAHIwjB,GAAYC,EAAGE,aAAaH,GAEhCC,EAAGG,IAAIxC,SACAvY,QAMX,IAAIgb,GAAYxiB,OAAOC,oBAAoB+hB,IAMvCS,IAAgB,EAEpB,SAASC,GAAiBxb,GACxBub,GAAgBvb,EASlB,IAAIyb,GAAW,SAAmBzb,GAChC3I,KAAK2I,MAAQA,EACb3I,KAAKgkB,IAAM,IAAIhD,GACfhhB,KAAKqkB,QAAU,EACfvd,EAAI6B,EAAO,SAAU3I,MACjBkC,MAAM4X,QAAQnR,IACZmW,EACFwF,GAAa3b,EAAO8a,IAEpBc,GAAY5b,EAAO8a,GAAcQ,IAEnCjkB,KAAK+jB,aAAapb,IAElB3I,KAAKwkB,KAAK7b,IA+Bd,SAAS2b,GAAc3kB,EAAQ8kB,GAE7B9kB,EAAO+kB,UAAYD,EASrB,SAASF,GAAa5kB,EAAQ8kB,EAAK7H,GACjC,IAAK,IAAIjc,EAAI,EAAG4a,EAAIqB,EAAK/d,OAAQ8B,EAAI4a,EAAG5a,IAAK,CAC3C,IAAIqN,EAAM4O,EAAKjc,GACfmG,EAAInH,EAAQqO,EAAKyW,EAAIzW,KASzB,SAAS2W,GAAShc,EAAOic,GAIvB,IAAIf,EAHJ,GAAK1jB,EAASwI,MAAUA,aAAiBmZ,IAkBzC,OAdIpH,EAAO/R,EAAO,WAAaA,EAAMmb,kBAAkBM,GACrDP,EAAKlb,EAAMmb,OAEXI,KACClE,OACA9d,MAAM4X,QAAQnR,IAAU6Q,EAAc7Q,KACvClH,OAAOojB,aAAalc,KACnBA,EAAMmc,SAEPjB,EAAK,IAAIO,GAASzb,IAEhBic,GAAcf,GAChBA,EAAGQ,UAEER,EAMT,SAASkB,GACPzL,EACAtL,EACAjG,EACAid,EACAC,GAEA,IAAIjB,EAAM,IAAIhD,GAEVkE,EAAWzjB,OAAOyB,yBAAyBoW,EAAKtL,GACpD,IAAIkX,IAAsC,IAA1BA,EAAShO,aAAzB,CAKA,IAAIiO,EAASD,GAAYA,EAAS3e,IAC9B6e,EAASF,GAAYA,EAAStE,IAC5BuE,IAAUC,GAAgC,IAArBhmB,UAAUP,SACnCkJ,EAAMuR,EAAItL,IAGZ,IAAIqX,GAAWJ,GAAWN,GAAQ5c,GAClCtG,OAAO6E,eAAegT,EAAKtL,EAAK,CAC9BuQ,YAAY,EACZrH,cAAc,EACd3Q,IAAK,WACH,IAAIoC,EAAQwc,EAASA,EAAOpmB,KAAKua,GAAOvR,EAUxC,OATIiZ,GAAIrhB,SACNqkB,EAAI1C,SACA+D,IACFA,EAAQrB,IAAI1C,SACRpf,MAAM4X,QAAQnR,IAChB2c,GAAY3c,KAIXA,GAETiY,IAAK,SAAyB2E,GAC5B,IAAI5c,EAAQwc,EAASA,EAAOpmB,KAAKua,GAAOvR,EAEpCwd,IAAW5c,GAAU4c,IAAWA,GAAU5c,IAAUA,GAQpDwc,IAAWC,IACXA,EACFA,EAAOrmB,KAAKua,EAAKiM,GAEjBxd,EAAMwd,EAERF,GAAWJ,GAAWN,GAAQY,GAC9BvB,EAAIxC,cAUV,SAASZ,GAAKjhB,EAAQqO,EAAKjG,GAMzB,GAAI7F,MAAM4X,QAAQna,IAAW8Z,EAAkBzL,GAG7C,OAFArO,EAAOd,OAASsG,KAAK2N,IAAInT,EAAOd,OAAQmP,GACxCrO,EAAO6a,OAAOxM,EAAK,EAAGjG,GACfA,EAET,GAAIiG,KAAOrO,KAAYqO,KAAOvM,OAAOP,WAEnC,OADAvB,EAAOqO,GAAOjG,EACPA,EAET,IAAI8b,EAAK,EAASC,OAClB,OAAInkB,EAAOmlB,QAAWjB,GAAMA,EAAGQ,QAKtBtc,EAEJ8b,GAILkB,GAAkBlB,EAAGlb,MAAOqF,EAAKjG,GACjC8b,EAAGG,IAAIxC,SACAzZ,IALLpI,EAAOqO,GAAOjG,EACPA,GAUX,SAASyd,GAAK7lB,EAAQqO,GAMpB,GAAI9L,MAAM4X,QAAQna,IAAW8Z,EAAkBzL,GAC7CrO,EAAO6a,OAAOxM,EAAK,OADrB,CAIA,IAAI6V,EAAK,EAASC,OACdnkB,EAAOmlB,QAAWjB,GAAMA,EAAGQ,SAO1B3J,EAAO/a,EAAQqO,YAGbrO,EAAOqO,GACT6V,GAGLA,EAAGG,IAAIxC,WAOT,SAAS8D,GAAa3c,GACpB,IAAK,IAAIoD,OAAI,EAAUpL,EAAI,EAAG4a,EAAI5S,EAAM9J,OAAQ8B,EAAI4a,EAAG5a,IACrDoL,EAAIpD,EAAMhI,GACVoL,GAAKA,EAAE+X,QAAU/X,EAAE+X,OAAOE,IAAI1C,SAC1Bpf,MAAM4X,QAAQ/N,IAChBuZ,GAAYvZ,GAhNlBqY,GAASljB,UAAUsjB,KAAO,SAAelL,GAEvC,IADA,IAAIsD,EAAOnb,OAAOmb,KAAKtD,GACd3Y,EAAI,EAAGA,EAAIic,EAAK/d,OAAQ8B,IAC/BokB,GAAkBzL,EAAKsD,EAAKjc,KAOhCyjB,GAASljB,UAAU6iB,aAAe,SAAuB0B,GACvD,IAAK,IAAI9kB,EAAI,EAAG4a,EAAIkK,EAAM5mB,OAAQ8B,EAAI4a,EAAG5a,IACvCgkB,GAAQc,EAAM9kB,KAgNlB,IAAI+kB,GAAS1hB,EAAOmZ,sBAoBpB,SAASwI,GAAW7J,EAAIpZ,GACtB,IAAKA,EAAQ,OAAOoZ,EAOpB,IANA,IAAI9N,EAAK4X,EAAOC,EAEZjJ,EAAO2D,GACPE,QAAQC,QAAQhe,GAChBjB,OAAOmb,KAAKla,GAEP/B,EAAI,EAAGA,EAAIic,EAAK/d,OAAQ8B,IAC/BqN,EAAM4O,EAAKjc,GAEC,WAARqN,IACJ4X,EAAQ9J,EAAG9N,GACX6X,EAAUnjB,EAAKsL,GACV0M,EAAOoB,EAAI9N,GAGd4X,IAAUC,GACVrM,EAAcoM,IACdpM,EAAcqM,IAEdF,GAAUC,EAAOC,GANjBjF,GAAI9E,EAAI9N,EAAK6X,IASjB,OAAO/J,EAMT,SAASgK,GACPC,EACAC,EACAC,GAEA,OAAKA,EAoBI,WAEL,IAAIC,EAAmC,oBAAbF,EACtBA,EAASjnB,KAAKknB,EAAIA,GAClBD,EACAG,EAAmC,oBAAdJ,EACrBA,EAAUhnB,KAAKknB,EAAIA,GACnBF,EACJ,OAAIG,EACKP,GAAUO,EAAcC,GAExBA,GA7BNH,EAGAD,EAQE,WACL,OAAOJ,GACe,oBAAbK,EAA0BA,EAASjnB,KAAKiB,KAAMA,MAAQgmB,EACxC,oBAAdD,EAA2BA,EAAUhnB,KAAKiB,KAAMA,MAAQ+lB,IAV1DC,EAHAD,EA2Db,SAASK,GACPL,EACAC,GAEA,IAAIxa,EAAMwa,EACND,EACEA,EAAU9kB,OAAO+kB,GACjB9jB,MAAM4X,QAAQkM,GACZA,EACA,CAACA,GACLD,EACJ,OAAOva,EACH6a,GAAY7a,GACZA,EAGN,SAAS6a,GAAaC,GAEpB,IADA,IAAI9a,EAAM,GACD7K,EAAI,EAAGA,EAAI2lB,EAAMznB,OAAQ8B,KACD,IAA3B6K,EAAIgL,QAAQ8P,EAAM3lB,KACpB6K,EAAI1G,KAAKwhB,EAAM3lB,IAGnB,OAAO6K,EAcT,SAAS+a,GACPR,EACAC,EACAC,EACAjY,GAEA,IAAIxC,EAAM/J,OAAO2Y,OAAO2L,GAAa,MACrC,OAAIC,EAEKnK,EAAOrQ,EAAKwa,GAEZxa,EAzEXka,GAAOzgB,KAAO,SACZ8gB,EACAC,EACAC,GAEA,OAAKA,EAcEH,GAAcC,EAAWC,EAAUC,GAbpCD,GAAgC,oBAAbA,EAQdD,EAEFD,GAAcC,EAAWC,IAmCpC9I,EAAgBzY,SAAQ,SAAUkT,GAChC+N,GAAO/N,GAAQyO,MAyBjBnJ,EAAYxY,SAAQ,SAAUwC,GAC5Bye,GAAOze,EAAO,KAAOsf,MASvBb,GAAO9F,MAAQ,SACbmG,EACAC,EACAC,EACAjY,GAMA,GAHI+X,IAAcpG,KAAeoG,OAAYjnB,GACzCknB,IAAarG,KAAeqG,OAAWlnB,IAEtCknB,EAAY,OAAOvkB,OAAO2Y,OAAO2L,GAAa,MAInD,IAAKA,EAAa,OAAOC,EACzB,IAAIpK,EAAM,GAEV,IAAK,IAAI4K,KADT3K,EAAOD,EAAKmK,GACMC,EAAU,CAC1B,IAAI/N,EAAS2D,EAAI4K,GACbxD,EAAQgD,EAASQ,GACjBvO,IAAW/V,MAAM4X,QAAQ7B,KAC3BA,EAAS,CAACA,IAEZ2D,EAAI4K,GAASvO,EACTA,EAAOhX,OAAO+hB,GACd9gB,MAAM4X,QAAQkJ,GAASA,EAAQ,CAACA,GAEtC,OAAOpH,GAMT8J,GAAO9e,MACP8e,GAAOtY,QACPsY,GAAOe,OACPf,GAAO5Y,SAAW,SAChBiZ,EACAC,EACAC,EACAjY,GAKA,IAAK+X,EAAa,OAAOC,EACzB,IAAIpK,EAAMna,OAAO2Y,OAAO,MAGxB,OAFAyB,EAAOD,EAAKmK,GACRC,GAAYnK,EAAOD,EAAKoK,GACrBpK,GAET8J,GAAOgB,QAAUZ,GAKjB,IAAIa,GAAe,SAAUZ,EAAWC,GACtC,YAAoBlnB,IAAbknB,EACHD,EACAC,GA+BN,SAASY,GAAgBxU,EAAS6T,GAChC,IAAIrf,EAAQwL,EAAQxL,MACpB,GAAKA,EAAL,CACA,IACIjG,EAAGoH,EAAKtF,EADR+I,EAAM,GAEV,GAAItJ,MAAM4X,QAAQlT,GAAQ,CACxBjG,EAAIiG,EAAM/H,OACV,MAAO8B,IACLoH,EAAMnB,EAAMjG,GACO,kBAARoH,IACTtF,EAAOqY,EAAS/S,GAChByD,EAAI/I,GAAQ,CAAEwE,KAAM,YAKnB,GAAIuS,EAAc5S,GACvB,IAAK,IAAIoH,KAAOpH,EACdmB,EAAMnB,EAAMoH,GACZvL,EAAOqY,EAAS9M,GAChBxC,EAAI/I,GAAQ+W,EAAczR,GACtBA,EACA,CAAEd,KAAMc,QAEL,EAOXqK,EAAQxL,MAAQ4E,GAMlB,SAASqb,GAAiBzU,EAAS6T,GACjC,IAAIQ,EAASrU,EAAQqU,OACrB,GAAKA,EAAL,CACA,IAAIK,EAAa1U,EAAQqU,OAAS,GAClC,GAAIvkB,MAAM4X,QAAQ2M,GAChB,IAAK,IAAI9lB,EAAI,EAAGA,EAAI8lB,EAAO5nB,OAAQ8B,IACjCmmB,EAAWL,EAAO9lB,IAAM,CAAE+B,KAAM+jB,EAAO9lB,SAEpC,GAAI6Y,EAAciN,GACvB,IAAK,IAAIzY,KAAOyY,EAAQ,CACtB,IAAI1e,EAAM0e,EAAOzY,GACjB8Y,EAAW9Y,GAAOwL,EAAczR,GAC5B8T,EAAO,CAAEnZ,KAAMsL,GAAOjG,GACtB,CAAErF,KAAMqF,QAEL,GAYb,SAASgf,GAAqB3U,GAC5B,IAAI4U,EAAO5U,EAAQ6U,WACnB,GAAID,EACF,IAAK,IAAIhZ,KAAOgZ,EAAM,CACpB,IAAIE,EAASF,EAAKhZ,GACI,oBAAXkZ,IACTF,EAAKhZ,GAAO,CAAElN,KAAMomB,EAAQzF,OAAQyF,KAoB5C,SAASC,GACPlP,EACA+K,EACAiD,GAkBA,GAZqB,oBAAVjD,IACTA,EAAQA,EAAM5Q,SAGhBwU,GAAe5D,EAAOiD,GACtBY,GAAgB7D,EAAOiD,GACvBc,GAAoB/D,IAMfA,EAAMoE,QACLpE,EAAMqE,UACRpP,EAASkP,GAAalP,EAAQ+K,EAAMqE,QAASpB,IAE3CjD,EAAMsE,QACR,IAAK,IAAI3mB,EAAI,EAAG4a,EAAIyH,EAAMsE,OAAOzoB,OAAQ8B,EAAI4a,EAAG5a,IAC9CsX,EAASkP,GAAalP,EAAQ+K,EAAMsE,OAAO3mB,GAAIslB,GAKrD,IACIjY,EADAoE,EAAU,GAEd,IAAKpE,KAAOiK,EACVsP,EAAWvZ,GAEb,IAAKA,KAAOgV,EACLtI,EAAOzC,EAAQjK,IAClBuZ,EAAWvZ,GAGf,SAASuZ,EAAYvZ,GACnB,IAAIwZ,EAAQ9B,GAAO1X,IAAQ2Y,GAC3BvU,EAAQpE,GAAOwZ,EAAMvP,EAAOjK,GAAMgV,EAAMhV,GAAMiY,EAAIjY,GAEpD,OAAOoE,EAQT,SAASqV,GACPrV,EACAnL,EACAga,EACAyG,GAGA,GAAkB,kBAAPzG,EAAX,CAGA,IAAI0G,EAASvV,EAAQnL,GAErB,GAAIyT,EAAOiN,EAAQ1G,GAAO,OAAO0G,EAAO1G,GACxC,IAAI2G,EAAc9M,EAASmG,GAC3B,GAAIvG,EAAOiN,EAAQC,GAAgB,OAAOD,EAAOC,GACjD,IAAIC,EAAe5M,EAAW2M,GAC9B,GAAIlN,EAAOiN,EAAQE,GAAiB,OAAOF,EAAOE,GAElD,IAAIrc,EAAMmc,EAAO1G,IAAO0G,EAAOC,IAAgBD,EAAOE,GAOtD,OAAOrc,GAOT,SAASsc,GACP9Z,EACA+Z,EACAC,EACA/B,GAEA,IAAIhe,EAAO8f,EAAY/Z,GACnBia,GAAUvN,EAAOsN,EAAWha,GAC5BrF,EAAQqf,EAAUha,GAElBka,EAAeC,GAAalb,QAAShF,EAAKhB,MAC9C,GAAIihB,GAAgB,EAClB,GAAID,IAAWvN,EAAOzS,EAAM,WAC1BU,GAAQ,OACH,GAAc,KAAVA,GAAgBA,IAAUwS,EAAUnN,GAAM,CAGnD,IAAIoa,EAAcD,GAAa1pB,OAAQwJ,EAAKhB,OACxCmhB,EAAc,GAAKF,EAAeE,KACpCzf,GAAQ,GAKd,QAAc7J,IAAV6J,EAAqB,CACvBA,EAAQ0f,GAAoBpC,EAAIhe,EAAM+F,GAGtC,IAAIsa,EAAoBpE,GACxBC,IAAgB,GAChBQ,GAAQhc,GACRwb,GAAgBmE,GASlB,OAAO3f,EAMT,SAAS0f,GAAqBpC,EAAIhe,EAAM+F,GAEtC,GAAK0M,EAAOzS,EAAM,WAAlB,CAGA,IAAInB,EAAMmB,EAAKf,QAYf,OAAI+e,GAAMA,EAAG1N,SAASyP,gBACWlpB,IAA/BmnB,EAAG1N,SAASyP,UAAUha,SACHlP,IAAnBmnB,EAAGsC,OAAOva,GAEHiY,EAAGsC,OAAOva,GAIG,oBAARlH,GAA6C,aAAvB0hB,GAAQvgB,EAAKhB,MAC7CH,EAAI/H,KAAKknB,GACTnf,GAqFN,SAAS0hB,GAAS7pB,GAChB,IAAIqH,EAAQrH,GAAMA,EAAG2C,WAAW0E,MAAM,sBACtC,OAAOA,EAAQA,EAAM,GAAK,GAG5B,SAASyiB,GAAYzpB,EAAGC,GACtB,OAAOupB,GAAQxpB,KAAOwpB,GAAQvpB,GAGhC,SAASkpB,GAAclhB,EAAMyhB,GAC3B,IAAKxmB,MAAM4X,QAAQ4O,GACjB,OAAOD,GAAWC,EAAezhB,GAAQ,GAAK,EAEhD,IAAK,IAAItG,EAAI,EAAGqB,EAAM0mB,EAAc7pB,OAAQ8B,EAAIqB,EAAKrB,IACnD,GAAI8nB,GAAWC,EAAc/nB,GAAIsG,GAC/B,OAAOtG,EAGX,OAAQ,EAgDV,SAASgoB,GAAaC,EAAK3C,EAAI4C,GAG7BlH,KACA,IACE,GAAIsE,EAAI,CACN,IAAI6C,EAAM7C,EACV,MAAQ6C,EAAMA,EAAIC,QAAU,CAC1B,IAAIzC,EAAQwC,EAAIvQ,SAASyQ,cACzB,GAAI1C,EACF,IAAK,IAAI3lB,EAAI,EAAGA,EAAI2lB,EAAMznB,OAAQ8B,IAChC,IACE,IAAIuF,GAAgD,IAAtCogB,EAAM3lB,GAAG5B,KAAK+pB,EAAKF,EAAK3C,EAAI4C,GAC1C,GAAI3iB,EAAW,OACf,MAAO6F,IACPkd,GAAkBld,GAAG+c,EAAK,wBAMpCG,GAAkBL,EAAK3C,EAAI4C,GAC3B,QACAjH,MAIJ,SAASsH,GACPC,EACArR,EACArX,EACAwlB,EACA4C,GAEA,IAAIrd,EACJ,IACEA,EAAM/K,EAAO0oB,EAAQhqB,MAAM2Y,EAASrX,GAAQ0oB,EAAQpqB,KAAK+Y,GACrDtM,IAAQA,EAAIsZ,QAAUlL,EAAUpO,KAASA,EAAI4d,WAC/C5d,EAAIqO,OAAM,SAAU9N,GAAK,OAAO4c,GAAY5c,EAAGka,EAAI4C,EAAO,uBAG1Drd,EAAI4d,UAAW,GAEjB,MAAOrd,IACP4c,GAAY5c,GAAGka,EAAI4C,GAErB,OAAOrd,EAGT,SAASyd,GAAmBL,EAAK3C,EAAI4C,GACnC,GAAI7kB,EAAOwZ,aACT,IACE,OAAOxZ,EAAOwZ,aAAaze,KAAK,KAAM6pB,EAAK3C,EAAI4C,GAC/C,MAAO9c,IAGHA,KAAM6c,GACRS,GAAStd,GAAG,KAAM,uBAIxBsd,GAAST,EAAK3C,EAAI4C,GAGpB,SAASQ,GAAUT,EAAK3C,EAAI4C,GAK1B,IAAK9J,IAAaC,GAA8B,qBAAZsK,QAGlC,MAAMV,EAFNU,QAAQznB,MAAM+mB,GAQlB,IAyBIW,GAzBAC,IAAmB,EAEnBC,GAAY,GACZC,IAAU,EAEd,SAASC,KACPD,IAAU,EACV,IAAIE,EAASH,GAAUrpB,MAAM,GAC7BqpB,GAAU5qB,OAAS,EACnB,IAAK,IAAI8B,EAAI,EAAGA,EAAIipB,EAAO/qB,OAAQ8B,IACjCipB,EAAOjpB,KAwBX,GAAuB,qBAAZ4D,SAA2B6b,GAAS7b,SAAU,CACvD,IAAIsH,GAAItH,QAAQC,UAChB+kB,GAAY,WACV1d,GAAE9G,KAAK4kB,IAMHlK,IAASoK,WAAW7N,IAE1BwN,IAAmB,OACd,GAAKlK,IAAoC,qBAArBwK,mBACzB1J,GAAS0J,mBAEuB,yCAAhCA,iBAAiBxoB,WAoBjBioB,GAJiC,qBAAjBQ,cAAgC3J,GAAS2J,cAI7C,WACVA,aAAaJ,KAIH,WACVE,WAAWF,GAAgB,QAzB5B,CAID,IAAIK,GAAU,EACVC,GAAW,IAAIH,iBAAiBH,IAChCO,GAAWC,SAASC,eAAe3rB,OAAOurB,KAC9CC,GAAStF,QAAQuF,GAAU,CACzBG,eAAe,IAEjBd,GAAY,WACVS,IAAWA,GAAU,GAAK,EAC1BE,GAASjlB,KAAOxG,OAAOurB,KAEzBR,IAAmB,EAerB,SAASc,GAAUC,EAAIlP,GACrB,IAAImP,EAiBJ,GAhBAf,GAAU3kB,MAAK,WACb,GAAIylB,EACF,IACEA,EAAGxrB,KAAKsc,GACR,MAAOtP,IACP4c,GAAY5c,GAAGsP,EAAK,iBAEbmP,GACTA,EAASnP,MAGRqO,KACHA,IAAU,EACVH,OAGGgB,GAAyB,qBAAZhmB,QAChB,OAAO,IAAIA,SAAQ,SAAUC,GAC3BgmB,EAAWhmB,KAiGjB,IAAIimB,GAAc,IAAInK,GAOtB,SAASoK,GAAU3iB,GACjB4iB,GAAU5iB,EAAK0iB,IACfA,GAAY5J,QAGd,SAAS8J,GAAW5iB,EAAK6iB,GACvB,IAAIjqB,EAAGic,EACHiO,EAAM3oB,MAAM4X,QAAQ/R,GACxB,MAAM8iB,IAAQ1qB,EAAS4H,IAAStG,OAAOqpB,SAAS/iB,IAAQA,aAAe+Z,IAAvE,CAGA,GAAI/Z,EAAI+b,OAAQ,CACd,IAAIiH,EAAQhjB,EAAI+b,OAAOE,IAAI/C,GAC3B,GAAI2J,EAAK7nB,IAAIgoB,GACX,OAEFH,EAAKxS,IAAI2S,GAEX,GAAIF,EAAK,CACPlqB,EAAIoH,EAAIlJ,OACR,MAAO8B,IAAOgqB,GAAU5iB,EAAIpH,GAAIiqB,OAC3B,CACLhO,EAAOnb,OAAOmb,KAAK7U,GACnBpH,EAAIic,EAAK/d,OACT,MAAO8B,IAAOgqB,GAAU5iB,EAAI6U,EAAKjc,IAAKiqB,KA6B1C,IAAII,GAAiBrQ,GAAO,SAAUlY,GACpC,IAAIwoB,EAA6B,MAAnBxoB,EAAK0D,OAAO,GAC1B1D,EAAOwoB,EAAUxoB,EAAKrC,MAAM,GAAKqC,EACjC,IAAIyoB,EAA6B,MAAnBzoB,EAAK0D,OAAO,GAC1B1D,EAAOyoB,EAAUzoB,EAAKrC,MAAM,GAAKqC,EACjC,IAAIyD,EAA6B,MAAnBzD,EAAK0D,OAAO,GAE1B,OADA1D,EAAOyD,EAAUzD,EAAKrC,MAAM,GAAKqC,EAC1B,CACLA,KAAMA,EACNsa,KAAMmO,EACNhlB,QAASA,EACT+kB,QAASA,MAIb,SAASE,GAAiBC,EAAKnF,GAC7B,SAASoF,IACP,IAAIC,EAAclsB,UAEdgsB,EAAMC,EAAQD,IAClB,IAAIlpB,MAAM4X,QAAQsR,GAOhB,OAAOlC,GAAwBkC,EAAK,KAAMhsB,UAAW6mB,EAAI,gBALzD,IADA,IAAI1C,EAAS6H,EAAIhrB,QACRO,EAAI,EAAGA,EAAI4iB,EAAO1kB,OAAQ8B,IACjCuoB,GAAwB3F,EAAO5iB,GAAI,KAAM2qB,EAAarF,EAAI,gBAQhE,OADAoF,EAAQD,IAAMA,EACPC,EAGT,SAASE,GACPnd,EACAod,EACApT,EACAqT,EACAC,EACAzF,GAEA,IAAIxjB,EAAcqmB,EAAK6C,EAAKC,EAC5B,IAAKnpB,KAAQ2L,EACF0a,EAAM1a,EAAG3L,GAClBkpB,EAAMH,EAAM/oB,GACZmpB,EAAQZ,GAAevoB,GACnBuW,EAAQ8P,KAKD9P,EAAQ2S,IACb3S,EAAQ8P,EAAIsC,OACdtC,EAAM1a,EAAG3L,GAAQ0oB,GAAgBrC,EAAK7C,IAEpC9M,EAAOyS,EAAM7O,QACf+L,EAAM1a,EAAG3L,GAAQipB,EAAkBE,EAAMnpB,KAAMqmB,EAAK8C,EAAM1lB,UAE5DkS,EAAIwT,EAAMnpB,KAAMqmB,EAAK8C,EAAM1lB,QAAS0lB,EAAMX,QAASW,EAAMC,SAChD/C,IAAQ6C,IACjBA,EAAIP,IAAMtC,EACV1a,EAAG3L,GAAQkpB,IAGf,IAAKlpB,KAAQ+oB,EACPxS,EAAQ5K,EAAG3L,MACbmpB,EAAQZ,GAAevoB,GACvBgpB,EAAUG,EAAMnpB,KAAM+oB,EAAM/oB,GAAOmpB,EAAM1lB,UAO/C,SAAS4lB,GAAgBhlB,EAAKilB,EAASpU,GAIrC,IAAI0T,EAHAvkB,aAAegb,KACjBhb,EAAMA,EAAI7B,KAAK0S,OAAS7Q,EAAI7B,KAAK0S,KAAO,KAG1C,IAAIqU,EAAUllB,EAAIilB,GAElB,SAASE,IACPtU,EAAKxY,MAAMa,KAAMZ,WAGjBkb,EAAO+Q,EAAQD,IAAKa,GAGlBjT,EAAQgT,GAEVX,EAAUF,GAAgB,CAACc,IAGvB/S,EAAM8S,EAAQZ,MAAQjS,EAAO6S,EAAQE,SAEvCb,EAAUW,EACVX,EAAQD,IAAItmB,KAAKmnB,IAGjBZ,EAAUF,GAAgB,CAACa,EAASC,IAIxCZ,EAAQa,QAAS,EACjBplB,EAAIilB,GAAWV,EAKjB,SAASc,GACPlnB,EACAob,EACAjY,GAKA,IAAI2f,EAAc1H,EAAKjO,QAAQxL,MAC/B,IAAIoS,EAAQ+O,GAAZ,CAGA,IAAIvc,EAAM,GACN0C,EAAQjJ,EAAKiJ,MACbtH,EAAQ3B,EAAK2B,MACjB,GAAIsS,EAAMhL,IAAUgL,EAAMtS,GACxB,IAAK,IAAIoH,KAAO+Z,EAAa,CAC3B,IAAIqE,EAASjR,EAAUnN,GAiBvBqe,GAAU7gB,EAAK5E,EAAOoH,EAAKoe,GAAQ,IACnCC,GAAU7gB,EAAK0C,EAAOF,EAAKoe,GAAQ,GAGvC,OAAO5gB,GAGT,SAAS6gB,GACP7gB,EACA8gB,EACAte,EACAoe,EACAG,GAEA,GAAIrT,EAAMoT,GAAO,CACf,GAAI5R,EAAO4R,EAAMte,GAKf,OAJAxC,EAAIwC,GAAOse,EAAKte,GACXue,UACID,EAAKte,IAEP,EACF,GAAI0M,EAAO4R,EAAMF,GAKtB,OAJA5gB,EAAIwC,GAAOse,EAAKF,GACXG,UACID,EAAKF,IAEP,EAGX,OAAO,EAiBT,SAASI,GAAyBhkB,GAChC,IAAK,IAAI7H,EAAI,EAAGA,EAAI6H,EAAS3J,OAAQ8B,IACnC,GAAIuB,MAAM4X,QAAQtR,EAAS7H,IACzB,OAAOuB,MAAMhB,UAAUD,OAAO9B,MAAM,GAAIqJ,GAG5C,OAAOA,EAOT,SAASikB,GAAmBjkB,GAC1B,OAAO6Q,EAAY7Q,GACf,CAAC4a,GAAgB5a,IACjBtG,MAAM4X,QAAQtR,GACZkkB,GAAuBlkB,QACvB1J,EAGR,SAAS6tB,GAAYxJ,GACnB,OAAOjK,EAAMiK,IAASjK,EAAMiK,EAAK3V,OAAS4L,EAAQ+J,EAAKT,WAGzD,SAASgK,GAAwBlkB,EAAUokB,GACzC,IACIjsB,EAAGzB,EAAGuL,EAAWoiB,EADjBrhB,EAAM,GAEV,IAAK7K,EAAI,EAAGA,EAAI6H,EAAS3J,OAAQ8B,IAC/BzB,EAAIsJ,EAAS7H,GACTqY,EAAQ9Z,IAAmB,mBAANA,IACzBuL,EAAYe,EAAI3M,OAAS,EACzBguB,EAAOrhB,EAAIf,GAEPvI,MAAM4X,QAAQ5a,GACZA,EAAEL,OAAS,IACbK,EAAIwtB,GAAuBxtB,GAAK0tB,GAAe,IAAM,IAAMjsB,GAEvDgsB,GAAWztB,EAAE,KAAOytB,GAAWE,KACjCrhB,EAAIf,GAAa2Y,GAAgByJ,EAAKrf,KAAQtO,EAAE,GAAIsO,MACpDtO,EAAE8F,SAEJwG,EAAI1G,KAAK3F,MAAMqM,EAAKtM,IAEbma,EAAYna,GACjBytB,GAAWE,GAIbrhB,EAAIf,GAAa2Y,GAAgByJ,EAAKrf,KAAOtO,GAC9B,KAANA,GAETsM,EAAI1G,KAAKse,GAAgBlkB,IAGvBytB,GAAWztB,IAAMytB,GAAWE,GAE9BrhB,EAAIf,GAAa2Y,GAAgByJ,EAAKrf,KAAOtO,EAAEsO,OAG3C2L,EAAO3Q,EAASskB,WAClB5T,EAAMha,EAAEkJ,MACR4Q,EAAQ9Z,EAAE8O,MACVkL,EAAM0T,KACN1tB,EAAE8O,IAAM,UAAY4e,EAAc,IAAMjsB,EAAI,MAE9C6K,EAAI1G,KAAK5F,KAIf,OAAOsM,EAKT,SAASuhB,GAAa9G,GACpB,IAAIS,EAAUT,EAAG1N,SAASmO,QACtBA,IACFT,EAAG+G,UAA+B,oBAAZtG,EAClBA,EAAQ3nB,KAAKknB,GACbS,GAIR,SAASuG,GAAgBhH,GACvB,IAAIhd,EAASikB,GAAcjH,EAAG1N,SAASkO,OAAQR,GAC3Chd,IACFkb,IAAgB,GAChB1iB,OAAOmb,KAAK3T,GAAQxE,SAAQ,SAAUuJ,GAYlC+W,GAAkBkB,EAAIjY,EAAK/E,EAAO+E,OAGtCmW,IAAgB,IAIpB,SAAS+I,GAAezG,EAAQR,GAC9B,GAAIQ,EAAQ,CAOV,IALA,IAAIxd,EAASxH,OAAO2Y,OAAO,MACvBwC,EAAO2D,GACPE,QAAQC,QAAQ+F,GAChBhlB,OAAOmb,KAAK6J,GAEP9lB,EAAI,EAAGA,EAAIic,EAAK/d,OAAQ8B,IAAK,CACpC,IAAIqN,EAAM4O,EAAKjc,GAEf,GAAY,WAARqN,EAAJ,CACA,IAAImf,EAAa1G,EAAOzY,GAAKtL,KACzB0I,EAAS6a,EACb,MAAO7a,EAAQ,CACb,GAAIA,EAAO4hB,WAAatS,EAAOtP,EAAO4hB,UAAWG,GAAa,CAC5DlkB,EAAO+E,GAAO5C,EAAO4hB,UAAUG,GAC/B,MAEF/hB,EAASA,EAAO2d,QAElB,IAAK3d,EACH,GAAI,YAAaqb,EAAOzY,GAAM,CAC5B,IAAIof,EAAiB3G,EAAOzY,GAAK9G,QACjC+B,EAAO+E,GAAiC,oBAAnBof,EACjBA,EAAeruB,KAAKknB,GACpBmH,OACK,GAKf,OAAOnkB,GAWX,SAASokB,GACP7kB,EACAsP,GAEA,IAAKtP,IAAaA,EAAS3J,OACzB,MAAO,GAGT,IADA,IAAIyuB,EAAQ,GACH3sB,EAAI,EAAG4a,EAAI/S,EAAS3J,OAAQ8B,EAAI4a,EAAG5a,IAAK,CAC/C,IAAIqiB,EAAQxa,EAAS7H,GACjBsE,EAAO+d,EAAM/d,KAOjB,GALIA,GAAQA,EAAKiJ,OAASjJ,EAAKiJ,MAAMqf,aAC5BtoB,EAAKiJ,MAAMqf,KAIfvK,EAAMlL,UAAYA,GAAWkL,EAAMb,YAAcrK,IACpD7S,GAAqB,MAAbA,EAAKsoB,MAUZD,EAAMpmB,UAAYomB,EAAMpmB,QAAU,KAAKpC,KAAKke,OAT7C,CACA,IAAIvgB,EAAOwC,EAAKsoB,KACZA,EAAQD,EAAM7qB,KAAU6qB,EAAM7qB,GAAQ,IACxB,aAAdugB,EAAM5a,IACRmlB,EAAKzoB,KAAK3F,MAAMouB,EAAMvK,EAAMxa,UAAY,IAExC+kB,EAAKzoB,KAAKke,IAOhB,IAAK,IAAIwK,KAAUF,EACbA,EAAME,GAAQhR,MAAMiR,YACfH,EAAME,GAGjB,OAAOF,EAGT,SAASG,GAActK,GACrB,OAAQA,EAAKT,YAAcS,EAAKlB,cAA+B,MAAdkB,EAAK3V,KAKxD,SAASkgB,GACPJ,EACAK,EACAC,GAEA,IAAIpiB,EACAqiB,EAAiBpsB,OAAOmb,KAAK+Q,GAAa9uB,OAAS,EACnDivB,EAAWR,IAAUA,EAAMS,SAAWF,EACtC7f,EAAMsf,GAASA,EAAMU,KACzB,GAAKV,EAEE,IAAIA,EAAMW,YAEf,OAAOX,EAAMW,YACR,GACLH,GACAF,GACAA,IAAc9U,GACd9K,IAAQ4f,EAAUI,OACjBH,IACAD,EAAUM,WAIX,OAAON,EAGP,IAAK,IAAIpH,KADThb,EAAM,GACY8hB,EACZA,EAAM9G,IAAuB,MAAbA,EAAM,KACxBhb,EAAIgb,GAAS2H,GAAoBR,EAAanH,EAAO8G,EAAM9G,UAnB/Dhb,EAAM,GAwBR,IAAK,IAAI4iB,KAAST,EACVS,KAAS5iB,IACbA,EAAI4iB,GAASC,GAAgBV,EAAaS,IAW9C,OANId,GAAS7rB,OAAOojB,aAAayI,KAC/B,EAAQW,YAAcziB,GAExB1E,EAAI0E,EAAK,UAAWsiB,GACpBhnB,EAAI0E,EAAK,OAAQwC,GACjBlH,EAAI0E,EAAK,aAAcqiB,GAChBriB,EAGT,SAAS2iB,GAAoBR,EAAa3f,EAAKrP,GAC7C,IAAImoB,EAAa,WACf,IAAItb,EAAMpM,UAAUP,OAASF,EAAGQ,MAAM,KAAMC,WAAaT,EAAG,IAI5D,OAHA6M,EAAMA,GAAsB,kBAARA,IAAqBtJ,MAAM4X,QAAQtO,GACnD,CAACA,GACDihB,GAAkBjhB,GACfA,IACU,IAAfA,EAAI3M,QACY,IAAf2M,EAAI3M,QAAgB2M,EAAI,GAAGkX,gBAC1B5jB,EACA0M,GAYN,OAPI7M,EAAG2vB,OACL7sB,OAAO6E,eAAeqnB,EAAa3f,EAAK,CACtCzH,IAAKugB,EACLvI,YAAY,EACZrH,cAAc,IAGX4P,EAGT,SAASuH,GAAgBf,EAAOtf,GAC9B,OAAO,WAAc,OAAOsf,EAAMtf,IAQpC,SAASugB,GACPxmB,EACAQ,GAEA,IAAIqT,EAAKjb,EAAG4a,EAAGqB,EAAM5O,EACrB,GAAI9L,MAAM4X,QAAQ/R,IAAuB,kBAARA,EAE/B,IADA6T,EAAM,IAAI1Z,MAAM6F,EAAIlJ,QACf8B,EAAI,EAAG4a,EAAIxT,EAAIlJ,OAAQ8B,EAAI4a,EAAG5a,IACjCib,EAAIjb,GAAK4H,EAAOR,EAAIpH,GAAIA,QAErB,GAAmB,kBAARoH,EAEhB,IADA6T,EAAM,IAAI1Z,MAAM6F,GACXpH,EAAI,EAAGA,EAAIoH,EAAKpH,IACnBib,EAAIjb,GAAK4H,EAAO5H,EAAI,EAAGA,QAEpB,GAAIR,EAAS4H,GAClB,GAAIwY,IAAaxY,EAAIyY,OAAOnO,UAAW,CACrCuJ,EAAM,GACN,IAAIvJ,EAAWtK,EAAIyY,OAAOnO,YACtBpJ,EAASoJ,EAASnB,OACtB,OAAQjI,EAAOwC,KACbmQ,EAAI9W,KAAKyD,EAAOU,EAAON,MAAOiT,EAAI/c,SAClCoK,EAASoJ,EAASnB,YAKpB,IAFA0L,EAAOnb,OAAOmb,KAAK7U,GACnB6T,EAAM,IAAI1Z,MAAM0a,EAAK/d,QAChB8B,EAAI,EAAG4a,EAAIqB,EAAK/d,OAAQ8B,EAAI4a,EAAG5a,IAClCqN,EAAM4O,EAAKjc,GACXib,EAAIjb,GAAK4H,EAAOR,EAAIiG,GAAMA,EAAKrN,GAQrC,OAJKuY,EAAM0C,KACTA,EAAM,IAER,EAAMkR,UAAW,EACVlR,EAQT,SAAS4S,GACP/rB,EACAgsB,EACA7nB,EACA8nB,GAEA,IACIC,EADAC,EAAe5uB,KAAK6uB,aAAapsB,GAEjCmsB,GACFhoB,EAAQA,GAAS,GACb8nB,IAOF9nB,EAAQiV,EAAOA,EAAO,GAAI6S,GAAa9nB,IAEzC+nB,EAAQC,EAAahoB,IAAU6nB,GAE/BE,EAAQ3uB,KAAKuN,OAAO9K,IAASgsB,EAG/B,IAAI9uB,EAASiH,GAASA,EAAM2mB,KAC5B,OAAI5tB,EACKK,KAAK8uB,eAAe,WAAY,CAAEvB,KAAM5tB,GAAUgvB,GAElDA,EASX,SAASI,GAAe9N,GACtB,OAAOwG,GAAaznB,KAAKuY,SAAU,UAAW0I,GAAI,IAAS/E,EAK7D,SAAS8S,GAAeC,EAAQC,GAC9B,OAAIhtB,MAAM4X,QAAQmV,IACmB,IAA5BA,EAAOzY,QAAQ0Y,GAEfD,IAAWC,EAStB,SAASC,GACPC,EACAphB,EACAqhB,EACAC,EACAC,GAEA,IAAIC,EAAgBxrB,EAAO2Z,SAAS3P,IAAQqhB,EAC5C,OAAIE,GAAkBD,IAAiBtrB,EAAO2Z,SAAS3P,GAC9CghB,GAAcO,EAAgBD,GAC5BE,EACFR,GAAcQ,EAAeJ,GAC3BE,EACFnU,EAAUmU,KAAkBthB,OAD9B,EAUT,SAASyhB,GACPxqB,EACAmD,EACAO,EACA+mB,EACAC,GAEA,GAAIhnB,EACF,GAAKxI,EAASwI,GAKP,CAIL,IAAI2jB,EAHApqB,MAAM4X,QAAQnR,KAChBA,EAAQpJ,EAASoJ,IAGnB,IAAIinB,EAAO,SAAW5hB,GACpB,GACU,UAARA,GACQ,UAARA,GACAqM,EAAoBrM,GAEpBse,EAAOrnB,MACF,CACL,IAAIgC,EAAOhC,EAAKiJ,OAASjJ,EAAKiJ,MAAMjH,KACpCqlB,EAAOoD,GAAU1rB,EAAOia,YAAY7V,EAAKnB,EAAM+G,GAC3C/I,EAAK4qB,WAAa5qB,EAAK4qB,SAAW,IAClC5qB,EAAKiJ,QAAUjJ,EAAKiJ,MAAQ,IAElC,IAAI4hB,EAAehV,EAAS9M,GACxB+hB,EAAgB5U,EAAUnN,GAC9B,KAAM8hB,KAAgBxD,MAAWyD,KAAiBzD,KAChDA,EAAKte,GAAOrF,EAAMqF,GAEd2hB,GAAQ,CACV,IAAIvhB,EAAKnJ,EAAKmJ,KAAOnJ,EAAKmJ,GAAK,IAC/BA,EAAI,UAAYJ,GAAQ,SAAUgiB,GAChCrnB,EAAMqF,GAAOgiB,KAMrB,IAAK,IAAIhiB,KAAOrF,EAAOinB,EAAM5hB,QAGjC,OAAO/I,EAQT,SAASgrB,GACP5kB,EACA6kB,GAEA,IAAIvV,EAAS3a,KAAKmwB,eAAiBnwB,KAAKmwB,aAAe,IACnDC,EAAOzV,EAAOtP,GAGlB,OAAI+kB,IAASF,IAIbE,EAAOzV,EAAOtP,GAASrL,KAAKuY,SAASlB,gBAAgBhM,GAAOtM,KAC1DiB,KAAKqwB,aACL,KACArwB,MAEFswB,GAAWF,EAAO,aAAe/kB,GAAQ,IARhC+kB,EAgBX,SAASG,GACPH,EACA/kB,EACA2C,GAGA,OADAsiB,GAAWF,EAAO,WAAa/kB,GAAS2C,EAAO,IAAMA,EAAO,KAAM,GAC3DoiB,EAGT,SAASE,GACPF,EACApiB,EACA4U,GAEA,GAAI1gB,MAAM4X,QAAQsW,GAChB,IAAK,IAAIzvB,EAAI,EAAGA,EAAIyvB,EAAKvxB,OAAQ8B,IAC3ByvB,EAAKzvB,IAAyB,kBAAZyvB,EAAKzvB,IACzB6vB,GAAeJ,EAAKzvB,GAAKqN,EAAM,IAAMrN,EAAIiiB,QAI7C4N,GAAeJ,EAAMpiB,EAAK4U,GAI9B,SAAS4N,GAAgBrN,EAAMnV,EAAK4U,GAClCO,EAAKX,UAAW,EAChBW,EAAKnV,IAAMA,EACXmV,EAAKP,OAASA,EAKhB,SAAS6N,GAAqBxrB,EAAM0D,GAClC,GAAIA,EACF,GAAK6Q,EAAc7Q,GAKZ,CACL,IAAIyF,EAAKnJ,EAAKmJ,GAAKnJ,EAAKmJ,GAAKyN,EAAO,GAAI5W,EAAKmJ,IAAM,GACnD,IAAK,IAAIJ,KAAOrF,EAAO,CACrB,IAAIgQ,EAAWvK,EAAGJ,GACd0iB,EAAO/nB,EAAMqF,GACjBI,EAAGJ,GAAO2K,EAAW,GAAG1X,OAAO0X,EAAU+X,GAAQA,QAIvD,OAAOzrB,EAKT,SAAS0rB,GACPvF,EACA5f,EAEAolB,EACAC,GAEArlB,EAAMA,GAAO,CAAEuiB,SAAU6C,GACzB,IAAK,IAAIjwB,EAAI,EAAGA,EAAIyqB,EAAIvsB,OAAQ8B,IAAK,CACnC,IAAI4sB,EAAOnC,EAAIzqB,GACXuB,MAAM4X,QAAQyT,GAChBoD,GAAmBpD,EAAM/hB,EAAKolB,GACrBrD,IAELA,EAAKe,QACPf,EAAK5uB,GAAG2vB,OAAQ,GAElB9iB,EAAI+hB,EAAKvf,KAAOuf,EAAK5uB,IAMzB,OAHIkyB,IACF,EAAM7C,KAAO6C,GAERrlB,EAKT,SAASslB,GAAiBC,EAAS1tB,GACjC,IAAK,IAAI1C,EAAI,EAAGA,EAAI0C,EAAOxE,OAAQ8B,GAAK,EAAG,CACzC,IAAIqN,EAAM3K,EAAO1C,GACE,kBAARqN,GAAoBA,IAC7B+iB,EAAQ1tB,EAAO1C,IAAM0C,EAAO1C,EAAI,IASpC,OAAOowB,EAMT,SAASC,GAAiBroB,EAAOsoB,GAC/B,MAAwB,kBAAVtoB,EAAqBsoB,EAAStoB,EAAQA,EAKtD,SAASuoB,GAAsBvxB,GAC7BA,EAAOwxB,GAAKZ,GACZ5wB,EAAOyxB,GAAKrX,EACZpa,EAAO0xB,GAAK/vB,EACZ3B,EAAO2xB,GAAK/C,GACZ5uB,EAAO4xB,GAAK/C,GACZ7uB,EAAO6xB,GAAKrV,EACZxc,EAAO8xB,GAAK3U,EACZnd,EAAO+xB,GAAKzB,GACZtwB,EAAOgyB,GAAK5C,GACZpvB,EAAOiyB,GAAKzC,GACZxvB,EAAOkyB,GAAKpC,GACZ9vB,EAAOmyB,GAAK1O,GACZzjB,EAAOoyB,GAAK7O,GACZvjB,EAAOqyB,GAAKrB,GACZhxB,EAAOsyB,GAAKxB,GACZ9wB,EAAOuyB,GAAKpB,GACZnxB,EAAOwyB,GAAKnB,GAKd,SAASoB,GACPntB,EACA2B,EACA4B,EACAyP,EACAoI,GAEA,IAKIgS,EALAC,EAAStyB,KAEToS,EAAUiO,EAAKjO,QAIfsI,EAAOzC,EAAQ,SACjBoa,EAAY5wB,OAAO2Y,OAAOnC,GAE1Boa,EAAUE,UAAYta,IAKtBoa,EAAYpa,EAEZA,EAASA,EAAOsa,WAElB,IAAIC,EAAarZ,EAAO/G,EAAQwF,WAC5B6a,GAAqBD,EAEzBxyB,KAAKiF,KAAOA,EACZjF,KAAK4G,MAAQA,EACb5G,KAAKwI,SAAWA,EAChBxI,KAAKiY,OAASA,EACdjY,KAAK0yB,UAAYztB,EAAKmJ,IAAM0K,EAC5B9Y,KAAK2yB,WAAazF,GAAc9a,EAAQqU,OAAQxO,GAChDjY,KAAKstB,MAAQ,WAOX,OANKgF,EAAO/kB,QACVmgB,GACEzoB,EAAK2tB,YACLN,EAAO/kB,OAAS8f,GAAa7kB,EAAUyP,IAGpCqa,EAAO/kB,QAGhB9L,OAAO6E,eAAetG,KAAM,cAAe,CACzCue,YAAY,EACZhY,IAAK,WACH,OAAOmnB,GAAqBzoB,EAAK2tB,YAAa5yB,KAAKstB,YAKnDkF,IAEFxyB,KAAKuY,SAAWnG,EAEhBpS,KAAKuN,OAASvN,KAAKstB,QACnBttB,KAAK6uB,aAAenB,GAAqBzoB,EAAK2tB,YAAa5yB,KAAKuN,SAG9D6E,EAAQyF,SACV7X,KAAK6yB,GAAK,SAAU7zB,EAAGC,EAAGC,EAAGoQ,GAC3B,IAAIgU,EAAQjd,GAAcgsB,EAAWrzB,EAAGC,EAAGC,EAAGoQ,EAAGmjB,GAKjD,OAJInP,IAAUphB,MAAM4X,QAAQwJ,KAC1BA,EAAMjB,UAAYjQ,EAAQyF,SAC1ByL,EAAMnB,UAAYlK,GAEbqL,GAGTtjB,KAAK6yB,GAAK,SAAU7zB,EAAGC,EAAGC,EAAGoQ,GAAK,OAAOjJ,GAAcgsB,EAAWrzB,EAAGC,EAAGC,EAAGoQ,EAAGmjB,IAMlF,SAASK,GACPzS,EACA2H,EACA/iB,EACAotB,EACA7pB,GAEA,IAAI4J,EAAUiO,EAAKjO,QACfxL,EAAQ,GACRmhB,EAAc3V,EAAQxL,MAC1B,GAAIsS,EAAM6O,GACR,IAAK,IAAI/Z,KAAO+Z,EACdnhB,EAAMoH,GAAO8Z,GAAa9Z,EAAK+Z,EAAaC,GAAalP,QAGvDI,EAAMjU,EAAKiJ,QAAU6kB,GAAWnsB,EAAO3B,EAAKiJ,OAC5CgL,EAAMjU,EAAK2B,QAAUmsB,GAAWnsB,EAAO3B,EAAK2B,OAGlD,IAAIosB,EAAgB,IAAIZ,GACtBntB,EACA2B,EACA4B,EACA6pB,EACAhS,GAGEiD,EAAQlR,EAAQ7J,OAAOxJ,KAAK,KAAMi0B,EAAcH,GAAIG,GAExD,GAAI1P,aAAiBxB,GACnB,OAAOmR,GAA6B3P,EAAOre,EAAM+tB,EAAc/a,OAAQ7F,EAAS4gB,GAC3E,GAAI9wB,MAAM4X,QAAQwJ,GAAQ,CAG/B,IAFA,IAAI4P,EAASzG,GAAkBnJ,IAAU,GACrC9X,EAAM,IAAItJ,MAAMgxB,EAAOr0B,QAClB8B,EAAI,EAAGA,EAAIuyB,EAAOr0B,OAAQ8B,IACjC6K,EAAI7K,GAAKsyB,GAA6BC,EAAOvyB,GAAIsE,EAAM+tB,EAAc/a,OAAQ7F,EAAS4gB,GAExF,OAAOxnB,GAIX,SAASynB,GAA8B3P,EAAOre,EAAMotB,EAAWjgB,EAAS4gB,GAItE,IAAIG,EAAQ9P,GAAWC,GASvB,OARA6P,EAAMhR,UAAYkQ,EAClBc,EAAM/Q,UAAYhQ,EAIdnN,EAAKsoB,QACN4F,EAAMluB,OAASkuB,EAAMluB,KAAO,KAAKsoB,KAAOtoB,EAAKsoB,MAEzC4F,EAGT,SAASJ,GAAYjX,EAAIpZ,GACvB,IAAK,IAAIsL,KAAOtL,EACdoZ,EAAGhB,EAAS9M,IAAQtL,EAAKsL,GA7D7BkjB,GAAqBkB,GAAwBlxB,WA0E7C,IAAIkyB,GAAsB,CACxBC,KAAM,SAAe/P,EAAOgQ,GAC1B,GACEhQ,EAAMhB,oBACLgB,EAAMhB,kBAAkBiR,cACzBjQ,EAAMre,KAAKuuB,UACX,CAEA,IAAIC,EAAcnQ,EAClB8P,GAAoBM,SAASD,EAAaA,OACrC,CACL,IAAIzQ,EAAQM,EAAMhB,kBAAoBqR,GACpCrQ,EACAsQ,IAEF5Q,EAAM6Q,OAAOP,EAAYhQ,EAAMvB,SAAMjjB,EAAWw0B,KAIpDI,SAAU,SAAmBI,EAAUxQ,GACrC,IAAIlR,EAAUkR,EAAMtB,iBAChBgB,EAAQM,EAAMhB,kBAAoBwR,EAASxR,kBAC/CyR,GACE/Q,EACA5Q,EAAQ4V,UACR5V,EAAQsgB,UACRpP,EACAlR,EAAQ5J,WAIZwrB,OAAQ,SAAiB1Q,GACvB,IAAIxL,EAAUwL,EAAMxL,QAChBwK,EAAoBgB,EAAMhB,kBACzBA,EAAkB2R,aACrB3R,EAAkB2R,YAAa,EAC/BC,GAAS5R,EAAmB,YAE1BgB,EAAMre,KAAKuuB,YACT1b,EAAQmc,WAMVE,GAAwB7R,GAExB8R,GAAuB9R,GAAmB,KAKhD+R,QAAS,SAAkB/Q,GACzB,IAAIhB,EAAoBgB,EAAMhB,kBACzBA,EAAkBiR,eAChBjQ,EAAMre,KAAKuuB,UAGdc,GAAyBhS,GAAmB,GAF5CA,EAAkBiS,cAQtBC,GAAe/yB,OAAOmb,KAAKwW,IAE/B,SAASqB,GACPpU,EACApb,EACA6S,EACAtP,EACAJ,GAEA,IAAI4Q,EAAQqH,GAAZ,CAIA,IAAIqU,EAAW5c,EAAQS,SAAS6O,MAShC,GANIjnB,EAASkgB,KACXA,EAAOqU,EAAS7Y,OAAOwE,IAKL,oBAATA,EAAX,CAQA,IAAI4B,EACJ,GAAIjJ,EAAQqH,EAAKsU,OACf1S,EAAe5B,EACfA,EAAOuU,GAAsB3S,EAAcyS,QAC9B51B,IAATuhB,GAIF,OAAOwU,GACL5S,EACAhd,EACA6S,EACAtP,EACAJ,GAKNnD,EAAOA,GAAQ,GAIf6vB,GAA0BzU,GAGtBnH,EAAMjU,EAAK8vB,QACbC,GAAe3U,EAAKjO,QAASnN,GAI/B,IAAI+iB,EAAYmE,GAA0BlnB,EAAMob,EAAMjY,GAGtD,GAAI+Q,EAAOkH,EAAKjO,QAAQjK,YACtB,OAAO2qB,GAA0BzS,EAAM2H,EAAW/iB,EAAM6S,EAAStP,GAKnE,IAAIkqB,EAAYztB,EAAKmJ,GAKrB,GAFAnJ,EAAKmJ,GAAKnJ,EAAKgwB,SAEX9b,EAAOkH,EAAKjO,QAAQ8iB,UAAW,CAKjC,IAAI3H,EAAOtoB,EAAKsoB,KAChBtoB,EAAO,GACHsoB,IACFtoB,EAAKsoB,KAAOA,GAKhB4H,GAAsBlwB,GAGtB,IAAIxC,EAAO4d,EAAKjO,QAAQ3P,MAAQ2F,EAC5Bkb,EAAQ,IAAIxB,GACb,iBAAoBzB,EAAQ,KAAK5d,EAAQ,IAAMA,EAAQ,IACxDwC,OAAMnG,OAAWA,OAAWA,EAAWgZ,EACvC,CAAEuI,KAAMA,EAAM2H,UAAWA,EAAW0K,UAAWA,EAAWtqB,IAAKA,EAAKI,SAAUA,GAC9EyZ,GAGF,OAAOqB,IAGT,SAASqQ,GACPrQ,EACArL,GAEA,IAAI7F,EAAU,CACZgjB,cAAc,EACdC,aAAc/R,EACdrL,OAAQA,GAGNqd,EAAiBhS,EAAMre,KAAKqwB,eAKhC,OAJIpc,EAAMoc,KACRljB,EAAQ7J,OAAS+sB,EAAe/sB,OAChC6J,EAAQiF,gBAAkBie,EAAeje,iBAEpC,IAAIiM,EAAMtB,iBAAiB3B,KAAKjO,GAGzC,SAAS+iB,GAAuBlwB,GAE9B,IADA,IAAIqhB,EAAQrhB,EAAK0S,OAAS1S,EAAK0S,KAAO,IAC7BhX,EAAI,EAAGA,EAAI6zB,GAAa31B,OAAQ8B,IAAK,CAC5C,IAAIqN,EAAMwmB,GAAa7zB,GACnBgY,EAAW2N,EAAMtY,GACjBunB,EAAUnC,GAAoBplB,GAC9B2K,IAAa4c,GAAa5c,GAAYA,EAAS6c,UACjDlP,EAAMtY,GAAO2K,EAAW8c,GAAYF,EAAS5c,GAAY4c,IAK/D,SAASE,GAAaC,EAAIC,GACxB,IAAIzJ,EAAS,SAAUltB,EAAGC,GAExBy2B,EAAG12B,EAAGC,GACN02B,EAAG32B,EAAGC,IAGR,OADAitB,EAAOsJ,SAAU,EACVtJ,EAKT,SAAS8I,GAAgB5iB,EAASnN,GAChC,IAAIgD,EAAQmK,EAAQ2iB,OAAS3iB,EAAQ2iB,MAAM9sB,MAAS,QAChD2jB,EAASxZ,EAAQ2iB,OAAS3iB,EAAQ2iB,MAAMnJ,OAAU,SACpD3mB,EAAKiJ,QAAUjJ,EAAKiJ,MAAQ,KAAKjG,GAAQhD,EAAK8vB,MAAMpsB,MACtD,IAAIyF,EAAKnJ,EAAKmJ,KAAOnJ,EAAKmJ,GAAK,IAC3BuK,EAAWvK,EAAGwd,GACdplB,EAAWvB,EAAK8vB,MAAMvuB,SACtB0S,EAAMP,IAENzW,MAAM4X,QAAQnB,IACsB,IAAhCA,EAASnC,QAAQhQ,GACjBmS,IAAanS,KAEjB4H,EAAGwd,GAAS,CAACplB,GAAUvF,OAAO0X,IAGhCvK,EAAGwd,GAASplB,EAMhB,IAAIovB,GAAmB,EACnBC,GAAmB,EAIvB,SAASxvB,GACPyR,EACA1P,EACAnD,EACAuD,EACAstB,EACAC,GAUA,OARI7zB,MAAM4X,QAAQ7U,IAASoU,EAAYpU,MACrC6wB,EAAoBttB,EACpBA,EAAWvD,EACXA,OAAOnG,GAELqa,EAAO4c,KACTD,EAAoBD,IAEfG,GAAele,EAAS1P,EAAKnD,EAAMuD,EAAUstB,GAGtD,SAASE,GACPle,EACA1P,EACAnD,EACAuD,EACAstB,GAEA,GAAI5c,EAAMjU,IAASiU,EAAM,EAAO4K,QAM9B,OAAOZ,KAMT,GAHIhK,EAAMjU,IAASiU,EAAMjU,EAAKgxB,MAC5B7tB,EAAMnD,EAAKgxB,KAER7tB,EAEH,OAAO8a,KA2BT,IAAII,EAAOpB,EAEL7B,GAdFne,MAAM4X,QAAQtR,IACO,oBAAhBA,EAAS,KAEhBvD,EAAOA,GAAQ,GACfA,EAAK2tB,YAAc,CAAE1rB,QAASsB,EAAS,IACvCA,EAAS3J,OAAS,GAEhBi3B,IAAsBD,GACxBrtB,EAAWikB,GAAkBjkB,GACpBstB,IAAsBF,KAC/BptB,EAAWgkB,GAAwBhkB,IAGlB,kBAARJ,IAET8Z,EAAMpK,EAAQC,QAAUD,EAAQC,OAAOmK,IAAOle,EAAO+Z,gBAAgB3V,GASnEkb,EAREtf,EAAO4Z,cAAcxV,GAQf,IAAI0Z,GACV9d,EAAOga,qBAAqB5V,GAAMnD,EAAMuD,OACxC1J,OAAWA,EAAWgZ,GAEb7S,GAASA,EAAKixB,MAAQhd,EAAMmH,EAAOoH,GAAa3P,EAAQS,SAAU,aAAcnQ,IAOnF,IAAI0Z,GACV1Z,EAAKnD,EAAMuD,OACX1J,OAAWA,EAAWgZ,GAPhB2c,GAAgBpU,EAAMpb,EAAM6S,EAAStP,EAAUJ,IAYzDkb,EAAQmR,GAAgBrsB,EAAKnD,EAAM6S,EAAStP,GAE9C,OAAItG,MAAM4X,QAAQwJ,GACTA,EACEpK,EAAMoK,IACXpK,EAAMgJ,IAAOiU,GAAQ7S,EAAOpB,GAC5BhJ,EAAMjU,IAASmxB,GAAqBnxB,GACjCqe,GAEAJ,KAIX,SAASiT,GAAS7S,EAAOpB,EAAImU,GAO3B,GANA/S,EAAMpB,GAAKA,EACO,kBAAdoB,EAAMlb,MAER8Z,OAAKpjB,EACLu3B,GAAQ,GAENnd,EAAMoK,EAAM9a,UACd,IAAK,IAAI7H,EAAI,EAAG4a,EAAI+H,EAAM9a,SAAS3J,OAAQ8B,EAAI4a,EAAG5a,IAAK,CACrD,IAAIqiB,EAAQM,EAAM9a,SAAS7H,GACvBuY,EAAM8J,EAAM5a,OACd4Q,EAAQgK,EAAMd,KAAQ/I,EAAOkd,IAAwB,QAAdrT,EAAM5a,MAC7C+tB,GAAQnT,EAAOd,EAAImU,IAS3B,SAASD,GAAsBnxB,GACzB9E,EAAS8E,EAAKuJ,QAChBkc,GAASzlB,EAAKuJ,OAEZrO,EAAS8E,EAAK6D,QAChB4hB,GAASzlB,EAAK6D,OAMlB,SAASwtB,GAAYrQ,GACnBA,EAAGsQ,OAAS,KACZtQ,EAAGkK,aAAe,KAClB,IAAI/d,EAAU6T,EAAG1N,SACbie,EAAcvQ,EAAGlO,OAAS3F,EAAQijB,aAClCrC,EAAgBwD,GAAeA,EAAY1e,QAC/CmO,EAAG1Y,OAAS8f,GAAajb,EAAQqkB,gBAAiBzD,GAClD/M,EAAG4I,aAAe/V,EAKlBmN,EAAG4M,GAAK,SAAU7zB,EAAGC,EAAGC,EAAGoQ,GAAK,OAAOjJ,GAAc4f,EAAIjnB,EAAGC,EAAGC,EAAGoQ,GAAG,IAGrE2W,EAAG6I,eAAiB,SAAU9vB,EAAGC,EAAGC,EAAGoQ,GAAK,OAAOjJ,GAAc4f,EAAIjnB,EAAGC,EAAGC,EAAGoQ,GAAG,IAIjF,IAAIonB,EAAaF,GAAeA,EAAYvxB,KAW1C8f,GAAkBkB,EAAI,SAAUyQ,GAAcA,EAAWxoB,OAAS4K,EAAa,MAAM,GACrFiM,GAAkBkB,EAAI,aAAc7T,EAAQukB,kBAAoB7d,EAAa,MAAM,GAIvF,IAkQInZ,GAlQAi3B,GAA2B,KAE/B,SAASC,GAAaC,GAEpB5F,GAAqB4F,EAAI51B,WAEzB41B,EAAI51B,UAAU61B,UAAY,SAAUp4B,GAClC,OAAO2rB,GAAS3rB,EAAIqB,OAGtB82B,EAAI51B,UAAU81B,QAAU,WACtB,IAiBI1T,EAjBA2C,EAAKjmB,KACLi3B,EAAMhR,EAAG1N,SACThQ,EAAS0uB,EAAI1uB,OACb8sB,EAAe4B,EAAI5B,aAEnBA,IACFpP,EAAG4I,aAAenB,GAChB2H,EAAapwB,KAAK2tB,YAClB3M,EAAG1Y,OACH0Y,EAAG4I,eAMP5I,EAAGlO,OAASsd,EAGZ,IAIEuB,GAA2B3Q,EAC3B3C,EAAQ/a,EAAOxJ,KAAKknB,EAAGoK,aAAcpK,EAAG6I,gBACxC,MAAO/iB,IACP4c,GAAY5c,GAAGka,EAAI,UAYjB3C,EAAQ2C,EAAGsQ,OAEb,QACAK,GAA2B,KAmB7B,OAhBI10B,MAAM4X,QAAQwJ,IAA2B,IAAjBA,EAAMzkB,SAChCykB,EAAQA,EAAM,IAGVA,aAAiBxB,KAQrBwB,EAAQJ,MAGVI,EAAMrL,OAASod,EACR/R,GAMX,SAAS4T,GAAYC,EAAMC,GAOzB,OALED,EAAKE,YACJ9W,IAA0C,WAA7B4W,EAAK3W,OAAO8W,gBAE1BH,EAAOA,EAAKjwB,SAEP/G,EAASg3B,GACZC,EAAKvb,OAAOsb,GACZA,EAGN,SAAStC,GACP0C,EACAtyB,EACA6S,EACAtP,EACAJ,GAEA,IAAI+a,EAAOD,KAGX,OAFAC,EAAKlB,aAAesV,EACpBpU,EAAKN,UAAY,CAAE5d,KAAMA,EAAM6S,QAASA,EAAStP,SAAUA,EAAUJ,IAAKA,GACnE+a,EAGT,SAASyR,GACP2C,EACA7C,GAEA,GAAIvb,EAAOoe,EAAQ11B,QAAUqX,EAAMqe,EAAQC,WACzC,OAAOD,EAAQC,UAGjB,GAAIte,EAAMqe,EAAQE,UAChB,OAAOF,EAAQE,SAGjB,IAAIC,EAAQd,GAMZ,GALIc,GAASxe,EAAMqe,EAAQI,UAA8C,IAAnCJ,EAAQI,OAAOnhB,QAAQkhB,IAE3DH,EAAQI,OAAO7yB,KAAK4yB,GAGlBve,EAAOoe,EAAQK,UAAY1e,EAAMqe,EAAQM,aAC3C,OAAON,EAAQM,YAGjB,GAAIH,IAAUxe,EAAMqe,EAAQI,QAAS,CACnC,IAAIA,EAASJ,EAAQI,OAAS,CAACD,GAC3BI,GAAO,EACPC,EAAe,KACfC,EAAe,KAElB,EAAQC,IAAI,kBAAkB,WAAc,OAAO3d,EAAOqd,EAAQD,MAEnE,IAAIQ,EAAc,SAAUC,GAC1B,IAAK,IAAIx3B,EAAI,EAAG4a,EAAIoc,EAAO94B,OAAQ8B,EAAI4a,EAAG5a,IACvCg3B,EAAOh3B,GAAIy3B,eAGVD,IACFR,EAAO94B,OAAS,EACK,OAAjBk5B,IACFM,aAAaN,GACbA,EAAe,MAEI,OAAjBC,IACFK,aAAaL,GACbA,EAAe,QAKjBxzB,EAAUuY,GAAK,SAAUvR,GAE3B+rB,EAAQE,SAAWP,GAAW1rB,EAAKkpB,GAG9BoD,EAGHH,EAAO94B,OAAS,EAFhBq5B,GAAY,MAMZI,EAASvb,GAAK,SAAUwb,GAKtBrf,EAAMqe,EAAQC,aAChBD,EAAQ11B,OAAQ,EAChBq2B,GAAY,OAIZ1sB,EAAM+rB,EAAQ/yB,EAAS8zB,GA+C3B,OA7CIn4B,EAASqL,KACPoO,EAAUpO,GAERwN,EAAQue,EAAQE,WAClBjsB,EAAIzG,KAAKP,EAAS8zB,GAEX1e,EAAUpO,EAAIgE,aACvBhE,EAAIgE,UAAUzK,KAAKP,EAAS8zB,GAExBpf,EAAM1N,EAAI3J,SACZ01B,EAAQC,UAAYN,GAAW1rB,EAAI3J,MAAO6yB,IAGxCxb,EAAM1N,EAAIosB,WACZL,EAAQM,YAAcX,GAAW1rB,EAAIosB,QAASlD,GAC5B,IAAdlpB,EAAIgtB,MACNjB,EAAQK,SAAU,EAElBG,EAAelO,YAAW,WACxBkO,EAAe,KACX/e,EAAQue,EAAQE,WAAaze,EAAQue,EAAQ11B,SAC/C01B,EAAQK,SAAU,EAClBM,GAAY,MAEb1sB,EAAIgtB,OAAS,MAIhBtf,EAAM1N,EAAI+J,WACZyiB,EAAenO,YAAW,WACxBmO,EAAe,KACXhf,EAAQue,EAAQE,WAClBa,EAGM,QAGP9sB,EAAI+J,YAKbuiB,GAAO,EAEAP,EAAQK,QACXL,EAAQM,YACRN,EAAQE,UAMhB,SAAS3U,GAAoBK,GAC3B,OAAOA,EAAKT,WAAaS,EAAKlB,aAKhC,SAASwW,GAAwBjwB,GAC/B,GAAItG,MAAM4X,QAAQtR,GAChB,IAAK,IAAI7H,EAAI,EAAGA,EAAI6H,EAAS3J,OAAQ8B,IAAK,CACxC,IAAIzB,EAAIsJ,EAAS7H,GACjB,GAAIuY,EAAMha,KAAOga,EAAMha,EAAE8iB,mBAAqBc,GAAmB5jB,IAC/D,OAAOA,GAUf,SAASw5B,GAAYzS,GACnBA,EAAG0S,QAAUl3B,OAAO2Y,OAAO,MAC3B6L,EAAG2S,eAAgB,EAEnB,IAAIlG,EAAYzM,EAAG1N,SAASoe,iBACxBjE,GACFmG,GAAyB5S,EAAIyM,GAMjC,SAASta,GAAKwT,EAAOjtB,GACnBgB,GAAOs4B,IAAIrM,EAAOjtB,GAGpB,SAASm6B,GAAUlN,EAAOjtB,GACxBgB,GAAOo5B,KAAKnN,EAAOjtB,GAGrB,SAAS+sB,GAAmBE,EAAOjtB,GACjC,IAAIq6B,EAAUr5B,GACd,OAAO,SAASs5B,IACd,IAAIztB,EAAM7M,EAAGQ,MAAM,KAAMC,WACb,OAARoM,GACFwtB,EAAQD,KAAKnN,EAAOqN,IAK1B,SAASJ,GACP5S,EACAyM,EACAwG,GAEAv5B,GAASsmB,EACTsF,GAAgBmH,EAAWwG,GAAgB,GAAI9gB,GAAK0gB,GAAUpN,GAAmBzF,GACjFtmB,QAASb,EAGX,SAASq6B,GAAarC,GACpB,IAAIsC,EAAS,SACbtC,EAAI51B,UAAU+2B,IAAM,SAAUrM,EAAOjtB,GACnC,IAAIsnB,EAAKjmB,KACT,GAAIkC,MAAM4X,QAAQ8R,GAChB,IAAK,IAAIjrB,EAAI,EAAG4a,EAAIqQ,EAAM/sB,OAAQ8B,EAAI4a,EAAG5a,IACvCslB,EAAGgS,IAAIrM,EAAMjrB,GAAIhC,QAGlBsnB,EAAG0S,QAAQ/M,KAAW3F,EAAG0S,QAAQ/M,GAAS,KAAK9mB,KAAKnG,GAGjDy6B,EAAO96B,KAAKstB,KACd3F,EAAG2S,eAAgB,GAGvB,OAAO3S,GAGT6Q,EAAI51B,UAAUm4B,MAAQ,SAAUzN,EAAOjtB,GACrC,IAAIsnB,EAAKjmB,KACT,SAASoO,IACP6X,EAAG8S,KAAKnN,EAAOxd,GACfzP,EAAGQ,MAAM8mB,EAAI7mB,WAIf,OAFAgP,EAAGzP,GAAKA,EACRsnB,EAAGgS,IAAIrM,EAAOxd,GACP6X,GAGT6Q,EAAI51B,UAAU63B,KAAO,SAAUnN,EAAOjtB,GACpC,IAAIsnB,EAAKjmB,KAET,IAAKZ,UAAUP,OAEb,OADAonB,EAAG0S,QAAUl3B,OAAO2Y,OAAO,MACpB6L,EAGT,GAAI/jB,MAAM4X,QAAQ8R,GAAQ,CACxB,IAAK,IAAI0N,EAAM,EAAG/d,EAAIqQ,EAAM/sB,OAAQy6B,EAAM/d,EAAG+d,IAC3CrT,EAAG8S,KAAKnN,EAAM0N,GAAM36B,GAEtB,OAAOsnB,EAGT,IASIsE,EATAgP,EAAMtT,EAAG0S,QAAQ/M,GACrB,IAAK2N,EACH,OAAOtT,EAET,IAAKtnB,EAEH,OADAsnB,EAAG0S,QAAQ/M,GAAS,KACb3F,EAIT,IAAItlB,EAAI44B,EAAI16B,OACZ,MAAO8B,IAEL,GADA4pB,EAAKgP,EAAI54B,GACL4pB,IAAO5rB,GAAM4rB,EAAG5rB,KAAOA,EAAI,CAC7B46B,EAAI/e,OAAO7Z,EAAG,GACd,MAGJ,OAAOslB,GAGT6Q,EAAI51B,UAAUs4B,MAAQ,SAAU5N,GAC9B,IAAI3F,EAAKjmB,KAaLu5B,EAAMtT,EAAG0S,QAAQ/M,GACrB,GAAI2N,EAAK,CACPA,EAAMA,EAAI16B,OAAS,EAAI6c,EAAQ6d,GAAOA,EAGtC,IAFA,IAAI94B,EAAOib,EAAQtc,UAAW,GAC1BypB,EAAO,sBAAyB+C,EAAQ,IACnCjrB,EAAI,EAAG4a,EAAIge,EAAI16B,OAAQ8B,EAAI4a,EAAG5a,IACrCuoB,GAAwBqQ,EAAI54B,GAAIslB,EAAIxlB,EAAMwlB,EAAI4C,GAGlD,OAAO5C,GAMX,IAAI2N,GAAiB,KAGrB,SAAS6F,GAAkBxT,GACzB,IAAIyT,EAAqB9F,GAEzB,OADAA,GAAiB3N,EACV,WACL2N,GAAiB8F,GAIrB,SAASC,GAAe1T,GACtB,IAAI7T,EAAU6T,EAAG1N,SAGbN,EAAS7F,EAAQ6F,OACrB,GAAIA,IAAW7F,EAAQ8iB,SAAU,CAC/B,MAAOjd,EAAOM,SAAS2c,UAAYjd,EAAO8Q,QACxC9Q,EAASA,EAAO8Q,QAElB9Q,EAAO2hB,UAAU90B,KAAKmhB,GAGxBA,EAAG8C,QAAU9Q,EACbgO,EAAG3N,MAAQL,EAASA,EAAOK,MAAQ2N,EAEnCA,EAAG2T,UAAY,GACf3T,EAAG4T,MAAQ,GAEX5T,EAAG6T,SAAW,KACd7T,EAAG8T,UAAY,KACf9T,EAAG+T,iBAAkB,EACrB/T,EAAGgO,YAAa,EAChBhO,EAAGsN,cAAe,EAClBtN,EAAGgU,mBAAoB,EAGzB,SAASC,GAAgBpD,GACvBA,EAAI51B,UAAUi5B,QAAU,SAAU7W,EAAOgQ,GACvC,IAAIrN,EAAKjmB,KACLo6B,EAASnU,EAAGoU,IACZC,EAAYrU,EAAGsQ,OACfgE,EAAwBd,GAAkBxT,GAC9CA,EAAGsQ,OAASjT,EAQV2C,EAAGoU,IALAC,EAKMrU,EAAGuU,UAAUF,EAAWhX,GAHxB2C,EAAGuU,UAAUvU,EAAGoU,IAAK/W,EAAOgQ,GAAW,GAKlDiH,IAEIH,IACFA,EAAOK,QAAU,MAEfxU,EAAGoU,MACLpU,EAAGoU,IAAII,QAAUxU,GAGfA,EAAGlO,QAAUkO,EAAG8C,SAAW9C,EAAGlO,SAAWkO,EAAG8C,QAAQwN,SACtDtQ,EAAG8C,QAAQsR,IAAMpU,EAAGoU,MAMxBvD,EAAI51B,UAAUk3B,aAAe,WAC3B,IAAInS,EAAKjmB,KACLimB,EAAG6T,UACL7T,EAAG6T,SAASrY,UAIhBqV,EAAI51B,UAAUqzB,SAAW,WACvB,IAAItO,EAAKjmB,KACT,IAAIimB,EAAGgU,kBAAP,CAGA/F,GAASjO,EAAI,iBACbA,EAAGgU,mBAAoB,EAEvB,IAAIhiB,EAASgO,EAAG8C,SACZ9Q,GAAWA,EAAOgiB,mBAAsBhU,EAAG1N,SAAS2c,UACtD5a,EAAOrC,EAAO2hB,UAAW3T,GAGvBA,EAAG6T,UACL7T,EAAG6T,SAASY,WAEd,IAAI/5B,EAAIslB,EAAG0U,UAAU97B,OACrB,MAAO8B,IACLslB,EAAG0U,UAAUh6B,GAAG+5B,WAIdzU,EAAG2U,MAAM9W,QACXmC,EAAG2U,MAAM9W,OAAOO,UAGlB4B,EAAGsN,cAAe,EAElBtN,EAAGuU,UAAUvU,EAAGsQ,OAAQ,MAExBrC,GAASjO,EAAI,aAEbA,EAAG8S,OAEC9S,EAAGoU,MACLpU,EAAGoU,IAAII,QAAU,MAGfxU,EAAGlO,SACLkO,EAAGlO,OAAOE,OAAS,QAKzB,SAAS4iB,GACP5U,EACA6U,EACAxH,GAyBA,IAAIyH,EA2CJ,OAlEA9U,EAAGoU,IAAMS,EACJ7U,EAAG1N,SAAShQ,SACf0d,EAAG1N,SAAShQ,OAAS2a,IAmBvBgR,GAASjO,EAAI,eAsBX8U,EAAkB,WAChB9U,EAAGkU,QAAQlU,EAAG+Q,UAAW1D,IAO7B,IAAI0H,GAAQ/U,EAAI8U,EAAiB/e,EAAM,CACrCif,OAAQ,WACFhV,EAAGgO,aAAehO,EAAGsN,cACvBW,GAASjO,EAAI,mBAGhB,GACHqN,GAAY,EAIK,MAAbrN,EAAGlO,SACLkO,EAAGgO,YAAa,EAChBC,GAASjO,EAAI,YAERA,EAGT,SAAS8N,GACP9N,EACA+B,EACA0K,EACA8D,EACA0E,GAYA,IAAIC,EAAiB3E,EAAYvxB,KAAK2tB,YAClCwI,EAAiBnV,EAAG4I,aACpBwM,KACDF,IAAmBA,EAAepN,SAClCqN,IAAmBtiB,IAAgBsiB,EAAerN,SAClDoN,GAAkBlV,EAAG4I,aAAab,OAASmN,EAAenN,MAMzDsN,KACFJ,GACAjV,EAAG1N,SAASke,iBACZ4E,GAkBF,GAfApV,EAAG1N,SAAS8c,aAAemB,EAC3BvQ,EAAGlO,OAASye,EAERvQ,EAAGsQ,SACLtQ,EAAGsQ,OAAOte,OAASue,GAErBvQ,EAAG1N,SAASke,gBAAkByE,EAK9BjV,EAAGsV,OAAS/E,EAAYvxB,KAAKiJ,OAAS4K,EACtCmN,EAAGuV,WAAa9I,GAAa5Z,EAGzBkP,GAAa/B,EAAG1N,SAAS3R,MAAO,CAClCud,IAAgB,GAGhB,IAFA,IAAIvd,EAAQqf,EAAGsC,OACXkT,EAAWxV,EAAG1N,SAASmjB,WAAa,GAC/B/6B,EAAI,EAAGA,EAAI86B,EAAS58B,OAAQ8B,IAAK,CACxC,IAAIqN,EAAMytB,EAAS96B,GACfonB,EAAc9B,EAAG1N,SAAS3R,MAC9BA,EAAMoH,GAAO8Z,GAAa9Z,EAAK+Z,EAAaC,EAAW/B,GAEzD9B,IAAgB,GAEhB8B,EAAG1N,SAASyP,UAAYA,EAI1B0K,EAAYA,GAAa5Z,EACzB,IAAIogB,EAAejT,EAAG1N,SAASoe,iBAC/B1Q,EAAG1N,SAASoe,iBAAmBjE,EAC/BmG,GAAyB5S,EAAIyM,EAAWwG,GAGpCoC,IACFrV,EAAG1Y,OAAS8f,GAAa6N,EAAgB1E,EAAY1e,SACrDmO,EAAGmS,gBAQP,SAASuD,GAAkB1V,GACzB,MAAOA,IAAOA,EAAKA,EAAG8C,SACpB,GAAI9C,EAAG8T,UAAa,OAAO,EAE7B,OAAO,EAGT,SAAS3F,GAAwBnO,EAAI2V,GACnC,GAAIA,GAEF,GADA3V,EAAG+T,iBAAkB,EACjB2B,GAAiB1V,GACnB,YAEG,GAAIA,EAAG+T,gBACZ,OAEF,GAAI/T,EAAG8T,WAA8B,OAAjB9T,EAAG8T,UAAoB,CACzC9T,EAAG8T,WAAY,EACf,IAAK,IAAIp5B,EAAI,EAAGA,EAAIslB,EAAG2T,UAAU/6B,OAAQ8B,IACvCyzB,GAAuBnO,EAAG2T,UAAUj5B,IAEtCuzB,GAASjO,EAAI,cAIjB,SAASqO,GAA0BrO,EAAI2V,GACrC,KAAIA,IACF3V,EAAG+T,iBAAkB,GACjB2B,GAAiB1V,OAIlBA,EAAG8T,UAAW,CACjB9T,EAAG8T,WAAY,EACf,IAAK,IAAIp5B,EAAI,EAAGA,EAAIslB,EAAG2T,UAAU/6B,OAAQ8B,IACvC2zB,GAAyBrO,EAAG2T,UAAUj5B,IAExCuzB,GAASjO,EAAI,gBAIjB,SAASiO,GAAUjO,EAAItO,GAErBgK,KACA,IAAIka,EAAW5V,EAAG1N,SAASZ,GACvBkR,EAAOlR,EAAO,QAClB,GAAIkkB,EACF,IAAK,IAAIl7B,EAAI,EAAGm7B,EAAID,EAASh9B,OAAQ8B,EAAIm7B,EAAGn7B,IAC1CuoB,GAAwB2S,EAASl7B,GAAIslB,EAAI,KAAMA,EAAI4C,GAGnD5C,EAAG2S,eACL3S,EAAGuT,MAAM,QAAU7hB,GAErBiK,KAKF,IAEIma,GAAQ,GACRC,GAAoB,GACpBj5B,GAAM,GAENk5B,IAAU,EACVC,IAAW,EACX7wB,GAAQ,EAKZ,SAAS8wB,KACP9wB,GAAQ0wB,GAAMl9B,OAASm9B,GAAkBn9B,OAAS,EAClDkE,GAAM,GAINk5B,GAAUC,IAAW,EAQvB,IAAIE,GAAwB,EAGxBC,GAAS5f,KAAK6f,IAQlB,GAAIvd,IAAcO,GAAM,CACtB,IAAI/B,GAAc/b,OAAO+b,YAEvBA,IAC2B,oBAApBA,GAAY+e,KACnBD,KAAWlS,SAASoS,YAAY,SAASC,YAMzCH,GAAS,WAAc,OAAO9e,GAAY+e,QAO9C,SAASG,KAGP,IAAIC,EAASzb,EAcb,IAhBAmb,GAAwBC,KACxBH,IAAW,EAWXH,GAAMY,MAAK,SAAU39B,EAAGC,GAAK,OAAOD,EAAEiiB,GAAKhiB,EAAEgiB,MAIxC5V,GAAQ,EAAGA,GAAQ0wB,GAAMl9B,OAAQwM,KACpCqxB,EAAUX,GAAM1wB,IACZqxB,EAAQzB,QACVyB,EAAQzB,SAEVha,EAAKyb,EAAQzb,GACble,GAAIke,GAAM,KACVyb,EAAQE,MAmBV,IAAIC,EAAiBb,GAAkB57B,QACnC08B,EAAef,GAAM37B,QAEzB+7B,KAGAY,GAAmBF,GACnBG,GAAiBF,GAIbxf,IAAYtZ,EAAOsZ,UACrBA,GAAS2f,KAAK,SAIlB,SAASD,GAAkBjB,GACzB,IAAIp7B,EAAIo7B,EAAMl9B,OACd,MAAO8B,IAAK,CACV,IAAI+7B,EAAUX,EAAMp7B,GAChBslB,EAAKyW,EAAQzW,GACbA,EAAG6T,WAAa4C,GAAWzW,EAAGgO,aAAehO,EAAGsN,cAClDW,GAASjO,EAAI,YASnB,SAASkO,GAAyBlO,GAGhCA,EAAG8T,WAAY,EACfiC,GAAkBl3B,KAAKmhB,GAGzB,SAAS8W,GAAoBhB,GAC3B,IAAK,IAAIp7B,EAAI,EAAGA,EAAIo7B,EAAMl9B,OAAQ8B,IAChCo7B,EAAMp7B,GAAGo5B,WAAY,EACrB3F,GAAuB2H,EAAMp7B,IAAI,GASrC,SAASu8B,GAAcR,GACrB,IAAIzb,EAAKyb,EAAQzb,GACjB,GAAe,MAAXle,GAAIke,GAAa,CAEnB,GADAle,GAAIke,IAAM,EACLib,GAEE,CAGL,IAAIv7B,EAAIo7B,GAAMl9B,OAAS,EACvB,MAAO8B,EAAI0K,IAAS0wB,GAAMp7B,GAAGsgB,GAAKyb,EAAQzb,GACxCtgB,IAEFo7B,GAAMvhB,OAAO7Z,EAAI,EAAG,EAAG+7B,QARvBX,GAAMj3B,KAAK43B,GAWRT,KACHA,IAAU,EAMV3R,GAASmS,MASf,IAAIU,GAAQ,EAORnC,GAAU,SACZ/U,EACAmX,EACA7S,EACAnY,EACAirB,GAEAr9B,KAAKimB,GAAKA,EACNoX,IACFpX,EAAG6T,SAAW95B,MAEhBimB,EAAG0U,UAAU71B,KAAK9E,MAEdoS,GACFpS,KAAKs9B,OAASlrB,EAAQkrB,KACtBt9B,KAAKu9B,OAASnrB,EAAQmrB,KACtBv9B,KAAKw9B,OAASprB,EAAQorB,KACtBx9B,KAAK83B,OAAS1lB,EAAQ0lB,KACtB93B,KAAKi7B,OAAS7oB,EAAQ6oB,QAEtBj7B,KAAKs9B,KAAOt9B,KAAKu9B,KAAOv9B,KAAKw9B,KAAOx9B,KAAK83B,MAAO,EAElD93B,KAAKuqB,GAAKA,EACVvqB,KAAKihB,KAAOkc,GACZn9B,KAAKy9B,QAAS,EACdz9B,KAAK09B,MAAQ19B,KAAKw9B,KAClBx9B,KAAK29B,KAAO,GACZ39B,KAAK49B,QAAU,GACf59B,KAAK69B,OAAS,IAAIvd,GAClBtgB,KAAK89B,UAAY,IAAIxd,GACrBtgB,KAAK+9B,WAED,GAEmB,oBAAZX,EACTp9B,KAAKmlB,OAASiY,GAEdp9B,KAAKmlB,OAASzG,EAAU0e,GACnBp9B,KAAKmlB,SACRnlB,KAAKmlB,OAASnJ,IASlBhc,KAAK2I,MAAQ3I,KAAKw9B,UACd1+B,EACAkB,KAAKuG,OAMXy0B,GAAQ95B,UAAUqF,IAAM,WAEtB,IAAIoC,EADJgZ,GAAW3hB,MAEX,IAAIimB,EAAKjmB,KAAKimB,GACd,IACEtd,EAAQ3I,KAAKmlB,OAAOpmB,KAAKknB,EAAIA,GAC7B,MAAOla,IACP,IAAI/L,KAAKu9B,KAGP,MAAMxxB,GAFN4c,GAAY5c,GAAGka,EAAK,uBAA2BjmB,KAAe,WAAI,KAIpE,QAGIA,KAAKs9B,MACP5S,GAAS/hB,GAEXiZ,KACA5hB,KAAKg+B,cAEP,OAAOr1B,GAMTqyB,GAAQ95B,UAAUqgB,OAAS,SAAiByC,GAC1C,IAAI/C,EAAK+C,EAAI/C,GACRjhB,KAAK89B,UAAU/6B,IAAIke,KACtBjhB,KAAK89B,UAAU1lB,IAAI6I,GACnBjhB,KAAK49B,QAAQ94B,KAAKkf,GACbhkB,KAAK69B,OAAO96B,IAAIke,IACnB+C,EAAI7C,OAAOnhB,QAQjBg7B,GAAQ95B,UAAU88B,YAAc,WAC9B,IAAIr9B,EAAIX,KAAK29B,KAAK9+B,OAClB,MAAO8B,IAAK,CACV,IAAIqjB,EAAMhkB,KAAK29B,KAAKh9B,GACfX,KAAK89B,UAAU/6B,IAAIihB,EAAI/C,KAC1B+C,EAAI3C,UAAUrhB,MAGlB,IAAIi+B,EAAMj+B,KAAK69B,OACf79B,KAAK69B,OAAS79B,KAAK89B,UACnB99B,KAAK89B,UAAYG,EACjBj+B,KAAK89B,UAAUjd,QACfod,EAAMj+B,KAAK29B,KACX39B,KAAK29B,KAAO39B,KAAK49B,QACjB59B,KAAK49B,QAAUK,EACfj+B,KAAK49B,QAAQ/+B,OAAS,GAOxBm8B,GAAQ95B,UAAUugB,OAAS,WAErBzhB,KAAKw9B,KACPx9B,KAAK09B,OAAQ,EACJ19B,KAAK83B,KACd93B,KAAK48B,MAELM,GAAal9B,OAQjBg7B,GAAQ95B,UAAU07B,IAAM,WACtB,GAAI58B,KAAKy9B,OAAQ,CACf,IAAI90B,EAAQ3I,KAAKuG,MACjB,GACEoC,IAAU3I,KAAK2I,OAIfxI,EAASwI,IACT3I,KAAKs9B,KACL,CAEA,IAAIY,EAAWl+B,KAAK2I,MAEpB,GADA3I,KAAK2I,MAAQA,EACT3I,KAAKu9B,KACP,IACEv9B,KAAKuqB,GAAGxrB,KAAKiB,KAAKimB,GAAItd,EAAOu1B,GAC7B,MAAOnyB,IACP4c,GAAY5c,GAAG/L,KAAKimB,GAAK,yBAA6BjmB,KAAe,WAAI,UAG3EA,KAAKuqB,GAAGxrB,KAAKiB,KAAKimB,GAAItd,EAAOu1B,MAUrClD,GAAQ95B,UAAUi9B,SAAW,WAC3Bn+B,KAAK2I,MAAQ3I,KAAKuG,MAClBvG,KAAK09B,OAAQ,GAMf1C,GAAQ95B,UAAUogB,OAAS,WACzB,IAAI3gB,EAAIX,KAAK29B,KAAK9+B,OAClB,MAAO8B,IACLX,KAAK29B,KAAKh9B,GAAG2gB,UAOjB0Z,GAAQ95B,UAAUw5B,SAAW,WAC3B,GAAI16B,KAAKy9B,OAAQ,CAIVz9B,KAAKimB,GAAGgU,mBACX3f,EAAOta,KAAKimB,GAAG0U,UAAW36B,MAE5B,IAAIW,EAAIX,KAAK29B,KAAK9+B,OAClB,MAAO8B,IACLX,KAAK29B,KAAKh9B,GAAG0gB,UAAUrhB,MAEzBA,KAAKy9B,QAAS,IAMlB,IAAIW,GAA2B,CAC7B7f,YAAY,EACZrH,cAAc,EACd3Q,IAAKyV,EACL4E,IAAK5E,GAGP,SAASsS,GAAO3uB,EAAQ0+B,EAAWrwB,GACjCowB,GAAyB73B,IAAM,WAC7B,OAAOvG,KAAKq+B,GAAWrwB,IAEzBowB,GAAyBxd,IAAM,SAAsB7Y,GACnD/H,KAAKq+B,GAAWrwB,GAAOjG,GAEzBtG,OAAO6E,eAAe3G,EAAQqO,EAAKowB,IAGrC,SAASE,GAAWrY,GAClBA,EAAG0U,UAAY,GACf,IAAI7a,EAAOmG,EAAG1N,SACVuH,EAAKlZ,OAAS23B,GAAUtY,EAAInG,EAAKlZ,OACjCkZ,EAAK1S,SAAWoxB,GAAYvY,EAAInG,EAAK1S,SACrC0S,EAAK7a,KACPw5B,GAASxY,GAETtB,GAAQsB,EAAG2U,MAAQ,IAAI,GAErB9a,EAAKhT,UAAY4xB,GAAazY,EAAInG,EAAKhT,UACvCgT,EAAKF,OAASE,EAAKF,QAAUD,IAC/Bgf,GAAU1Y,EAAInG,EAAKF,OAIvB,SAAS2e,GAAWtY,EAAI2Y,GACtB,IAAI5W,EAAY/B,EAAG1N,SAASyP,WAAa,GACrCphB,EAAQqf,EAAGsC,OAAS,GAGpB3L,EAAOqJ,EAAG1N,SAASmjB,UAAY,GAC/BmD,GAAU5Y,EAAG8C,QAEZ8V,GACH1a,IAAgB,GAElB,IAAIyL,EAAO,SAAW5hB,GACpB4O,EAAK9X,KAAKkJ,GACV,IAAIrF,EAAQmf,GAAa9Z,EAAK4wB,EAAc5W,EAAW/B,GAuBrDlB,GAAkBne,EAAOoH,EAAKrF,GAK1BqF,KAAOiY,GACXqI,GAAMrI,EAAI,SAAUjY,IAIxB,IAAK,IAAIA,KAAO4wB,EAAchP,EAAM5hB,GACpCmW,IAAgB,GAGlB,SAASsa,GAAUxY,GACjB,IAAIhhB,EAAOghB,EAAG1N,SAAStT,KACvBA,EAAOghB,EAAG2U,MAAwB,oBAAT31B,EACrB65B,GAAQ75B,EAAMghB,GACdhhB,GAAQ,GACPuU,EAAcvU,KACjBA,EAAO,IAQT,IAAI2X,EAAOnb,OAAOmb,KAAK3X,GACnB2B,EAAQqf,EAAG1N,SAAS3R,MAEpBjG,GADUslB,EAAG1N,SAASnL,QAClBwP,EAAK/d,QACb,MAAO8B,IAAK,CACV,IAAIqN,EAAM4O,EAAKjc,GACX,EAQAiG,GAAS8T,EAAO9T,EAAOoH,IAMfqQ,EAAWrQ,IACrBsgB,GAAMrI,EAAI,QAASjY,GAIvB2W,GAAQ1f,GAAM,GAGhB,SAAS65B,GAAS75B,EAAMghB,GAEtBtE,KACA,IACE,OAAO1c,EAAKlG,KAAKknB,EAAIA,GACrB,MAAOla,IAEP,OADA4c,GAAY5c,GAAGka,EAAI,UACZ,GACP,QACArE,MAIJ,IAAImd,GAAyB,CAAEvB,MAAM,GAErC,SAASkB,GAAczY,EAAInZ,GAEzB,IAAIkyB,EAAW/Y,EAAGgZ,kBAAoBx9B,OAAO2Y,OAAO,MAEhD8kB,EAAQlf,KAEZ,IAAK,IAAIhS,KAAOlB,EAAU,CACxB,IAAIqyB,EAAUryB,EAASkB,GACnBmX,EAA4B,oBAAZga,EAAyBA,EAAUA,EAAQ54B,IAC3D,EAOC24B,IAEHF,EAAShxB,GAAO,IAAIgtB,GAClB/U,EACAd,GAAUnJ,EACVA,EACA+iB,KAOE/wB,KAAOiY,GACXmZ,GAAenZ,EAAIjY,EAAKmxB,IAW9B,SAASC,GACPz/B,EACAqO,EACAmxB,GAEA,IAAIE,GAAerf,KACI,oBAAZmf,GACTf,GAAyB73B,IAAM84B,EAC3BC,GAAqBtxB,GACrBuxB,GAAoBJ,GACxBf,GAAyBxd,IAAM5E,IAE/BoiB,GAAyB73B,IAAM44B,EAAQ54B,IACnC84B,IAAiC,IAAlBF,EAAQj3B,MACrBo3B,GAAqBtxB,GACrBuxB,GAAoBJ,EAAQ54B,KAC9ByV,EACJoiB,GAAyBxd,IAAMue,EAAQve,KAAO5E,GAWhDva,OAAO6E,eAAe3G,EAAQqO,EAAKowB,IAGrC,SAASkB,GAAsBtxB,GAC7B,OAAO,WACL,IAAI0uB,EAAU18B,KAAKi/B,mBAAqBj/B,KAAKi/B,kBAAkBjxB,GAC/D,GAAI0uB,EAOF,OANIA,EAAQgB,OACVhB,EAAQyB,WAENnd,GAAIrhB,QACN+8B,EAAQpb,SAEHob,EAAQ/zB,OAKrB,SAAS42B,GAAoB5gC,GAC3B,OAAO,WACL,OAAOA,EAAGI,KAAKiB,KAAMA,OAIzB,SAASw+B,GAAavY,EAAI7Y,GACZ6Y,EAAG1N,SAAS3R,MACxB,IAAK,IAAIoH,KAAOZ,EAsBd6Y,EAAGjY,GAA+B,oBAAjBZ,EAAQY,GAAsBgO,EAAOlb,EAAKsM,EAAQY,GAAMiY,GAI7E,SAAS0Y,GAAW1Y,EAAIrG,GACtB,IAAK,IAAI5R,KAAO4R,EAAO,CACrB,IAAIuJ,EAAUvJ,EAAM5R,GACpB,GAAI9L,MAAM4X,QAAQqP,GAChB,IAAK,IAAIxoB,EAAI,EAAGA,EAAIwoB,EAAQtqB,OAAQ8B,IAClC6+B,GAAcvZ,EAAIjY,EAAKmb,EAAQxoB,SAGjC6+B,GAAcvZ,EAAIjY,EAAKmb,IAK7B,SAASqW,GACPvZ,EACAmX,EACAjU,EACA/W,GASA,OAPIoH,EAAc2P,KAChB/W,EAAU+W,EACVA,EAAUA,EAAQA,SAEG,kBAAZA,IACTA,EAAUlD,EAAGkD,IAERlD,EAAGwZ,OAAOrC,EAASjU,EAAS/W,GAGrC,SAASstB,GAAY5I,GAInB,IAAI6I,EAAU,CACd,IAAc,WAAc,OAAO3/B,KAAK46B,QACpCgF,EAAW,CACf,IAAe,WAAc,OAAO5/B,KAAKuoB,SAazC9mB,OAAO6E,eAAewwB,EAAI51B,UAAW,QAASy+B,GAC9Cl+B,OAAO6E,eAAewwB,EAAI51B,UAAW,SAAU0+B,GAE/C9I,EAAI51B,UAAU2+B,KAAOjf,GACrBkW,EAAI51B,UAAU4+B,QAAUta,GAExBsR,EAAI51B,UAAUu+B,OAAS,SACrBrC,EACA7S,EACAnY,GAEA,IAAI6T,EAAKjmB,KACT,GAAIwZ,EAAc+Q,GAChB,OAAOiV,GAAcvZ,EAAImX,EAAS7S,EAAInY,GAExCA,EAAUA,GAAW,GACrBA,EAAQmrB,MAAO,EACf,IAAIb,EAAU,IAAI1B,GAAQ/U,EAAImX,EAAS7S,EAAInY,GAC3C,GAAIA,EAAQ2tB,UACV,IACExV,EAAGxrB,KAAKknB,EAAIyW,EAAQ/zB,OACpB,MAAO9G,GACP8mB,GAAY9mB,EAAOokB,EAAK,mCAAuCyW,EAAkB,WAAI,KAGzF,OAAO,WACLA,EAAQhC,aAOd,IAAIsF,GAAQ,EAEZ,SAASC,GAAWnJ,GAClBA,EAAI51B,UAAUg/B,MAAQ,SAAU9tB,GAC9B,IAAI6T,EAAKjmB,KAETimB,EAAGka,KAAOH,KAWV/Z,EAAGnB,QAAS,EAER1S,GAAWA,EAAQgjB,aAIrBgL,GAAsBna,EAAI7T,GAE1B6T,EAAG1N,SAAW4O,GACZ2N,GAA0B7O,EAAGzjB,aAC7B4P,GAAW,GACX6T,GAOFA,EAAGoK,aAAepK,EAGpBA,EAAGoa,MAAQpa,EACX0T,GAAc1T,GACdyS,GAAWzS,GACXqQ,GAAWrQ,GACXiO,GAASjO,EAAI,gBACbgH,GAAehH,GACfqY,GAAUrY,GACV8G,GAAY9G,GACZiO,GAASjO,EAAI,WASTA,EAAG1N,SAASuiB,IACd7U,EAAG4N,OAAO5N,EAAG1N,SAASuiB,KAK5B,SAASsF,GAAuBna,EAAI7T,GAClC,IAAI0N,EAAOmG,EAAG1N,SAAW9W,OAAO2Y,OAAO6L,EAAGzjB,YAAY4P,SAElDokB,EAAcpkB,EAAQijB,aAC1BvV,EAAK7H,OAAS7F,EAAQ6F,OACtB6H,EAAKuV,aAAemB,EAEpB,IAAI8J,EAAwB9J,EAAYxU,iBACxClC,EAAKkI,UAAYsY,EAAsBtY,UACvClI,EAAK6W,iBAAmB2J,EAAsB5N,UAC9C5S,EAAK2W,gBAAkB6J,EAAsB93B,SAC7CsX,EAAKygB,cAAgBD,EAAsBl4B,IAEvCgK,EAAQ7J,SACVuX,EAAKvX,OAAS6J,EAAQ7J,OACtBuX,EAAKzI,gBAAkBjF,EAAQiF,iBAInC,SAASyd,GAA2BzU,GAClC,IAAIjO,EAAUiO,EAAKjO,QACnB,GAAIiO,EAAKmgB,MAAO,CACd,IAAIC,EAAe3L,GAA0BzU,EAAKmgB,OAC9CE,EAAqBrgB,EAAKogB,aAC9B,GAAIA,IAAiBC,EAAoB,CAGvCrgB,EAAKogB,aAAeA,EAEpB,IAAIE,EAAkBC,GAAuBvgB,GAEzCsgB,GACF9kB,EAAOwE,EAAKwgB,cAAeF,GAE7BvuB,EAAUiO,EAAKjO,QAAU+U,GAAasZ,EAAcpgB,EAAKwgB,eACrDzuB,EAAQ3P,OACV2P,EAAQ0uB,WAAW1uB,EAAQ3P,MAAQ4d,IAIzC,OAAOjO,EAGT,SAASwuB,GAAwBvgB,GAC/B,IAAI0gB,EACAC,EAAS3gB,EAAKjO,QACd6uB,EAAS5gB,EAAK6gB,cAClB,IAAK,IAAIlzB,KAAOgzB,EACVA,EAAOhzB,KAASizB,EAAOjzB,KACpB+yB,IAAYA,EAAW,IAC5BA,EAAS/yB,GAAOgzB,EAAOhzB,IAG3B,OAAO+yB,EAGT,SAASjK,GAAK1kB,GAMZpS,KAAKkgC,MAAM9tB,GAWb,SAAS+uB,GAASrK,GAChBA,EAAIsK,IAAM,SAAUC,GAClB,IAAIC,EAAoBthC,KAAKuhC,oBAAsBvhC,KAAKuhC,kBAAoB,IAC5E,GAAID,EAAiB9qB,QAAQ6qB,IAAW,EACtC,OAAOrhC,KAIT,IAAIS,EAAOib,EAAQtc,UAAW,GAQ9B,OAPAqB,EAAKkE,QAAQ3E,MACiB,oBAAnBqhC,EAAOG,QAChBH,EAAOG,QAAQriC,MAAMkiC,EAAQ5gC,GACF,oBAAX4gC,GAChBA,EAAOliC,MAAM,KAAMsB,GAErB6gC,EAAiBx8B,KAAKu8B,GACfrhC,MAMX,SAASyhC,GAAa3K,GACpBA,EAAI4K,MAAQ,SAAUA,GAEpB,OADA1hC,KAAKoS,QAAU+U,GAAannB,KAAKoS,QAASsvB,GACnC1hC,MAMX,SAAS2hC,GAAY7K,GAMnBA,EAAInC,IAAM,EACV,IAAIA,EAAM,EAKVmC,EAAIjb,OAAS,SAAUglB,GACrBA,EAAgBA,GAAiB,GACjC,IAAIe,EAAQ5hC,KACR6hC,EAAUD,EAAMjN,IAChBmN,EAAcjB,EAAckB,QAAUlB,EAAckB,MAAQ,IAChE,GAAID,EAAYD,GACd,OAAOC,EAAYD,GAGrB,IAAIp/B,EAAOo+B,EAAcp+B,MAAQm/B,EAAMxvB,QAAQ3P,KAK/C,IAAIu/B,EAAM,SAAuB5vB,GAC/BpS,KAAKkgC,MAAM9tB,IA6Cb,OA3CA4vB,EAAI9gC,UAAYO,OAAO2Y,OAAOwnB,EAAM1gC,WACpC8gC,EAAI9gC,UAAUsB,YAAcw/B,EAC5BA,EAAIrN,IAAMA,IACVqN,EAAI5vB,QAAU+U,GACZya,EAAMxvB,QACNyuB,GAEFmB,EAAI,SAAWJ,EAKXI,EAAI5vB,QAAQxL,OACdq7B,GAAYD,GAEVA,EAAI5vB,QAAQtF,UACdo1B,GAAeF,GAIjBA,EAAInmB,OAAS+lB,EAAM/lB,OACnBmmB,EAAIN,MAAQE,EAAMF,MAClBM,EAAIZ,IAAMQ,EAAMR,IAIhBnkB,EAAYxY,SAAQ,SAAUwC,GAC5B+6B,EAAI/6B,GAAQ26B,EAAM36B,MAGhBxE,IACFu/B,EAAI5vB,QAAQ0uB,WAAWr+B,GAAQu/B,GAMjCA,EAAIvB,aAAemB,EAAMxvB,QACzB4vB,EAAInB,cAAgBA,EACpBmB,EAAId,cAAgBrlB,EAAO,GAAImmB,EAAI5vB,SAGnC0vB,EAAYD,GAAWG,EAChBA,GAIX,SAASC,GAAaE,GACpB,IAAIv7B,EAAQu7B,EAAK/vB,QAAQxL,MACzB,IAAK,IAAIoH,KAAOpH,EACd0nB,GAAM6T,EAAKjhC,UAAW,SAAU8M,GAIpC,SAASk0B,GAAgBC,GACvB,IAAIr1B,EAAWq1B,EAAK/vB,QAAQtF,SAC5B,IAAK,IAAIkB,KAAOlB,EACdsyB,GAAe+C,EAAKjhC,UAAW8M,EAAKlB,EAASkB,IAMjD,SAASo0B,GAAoBtL,GAI3B7Z,EAAYxY,SAAQ,SAAUwC,GAC5B6vB,EAAI7vB,GAAQ,SACVga,EACAohB,GAEA,OAAKA,GAOU,cAATp7B,GAAwBuS,EAAc6oB,KACxCA,EAAW5/B,KAAO4/B,EAAW5/B,MAAQwe,EACrCohB,EAAariC,KAAKoS,QAAQgV,MAAMvL,OAAOwmB,IAE5B,cAATp7B,GAA8C,oBAAfo7B,IACjCA,EAAa,CAAEvhC,KAAMuhC,EAAY5gB,OAAQ4gB,IAE3CriC,KAAKoS,QAAQnL,EAAO,KAAKga,GAAMohB,EACxBA,GAdAriC,KAAKoS,QAAQnL,EAAO,KAAKga,OAwBxC,SAASqhB,GAAkBxiB,GACzB,OAAOA,IAASA,EAAKO,KAAKjO,QAAQ3P,MAAQqd,EAAK1X,KAGjD,SAASm6B,GAASC,EAAS//B,GACzB,OAAIP,MAAM4X,QAAQ0oB,GACTA,EAAQhsB,QAAQ/T,IAAS,EACJ,kBAAZ+/B,EACTA,EAAQp4B,MAAM,KAAKoM,QAAQ/T,IAAS,IAClC4G,EAASm5B,IACXA,EAAQlkC,KAAKmE,GAMxB,SAASggC,GAAYC,EAAmBC,GACtC,IAAIz6B,EAAQw6B,EAAkBx6B,MAC1B0U,EAAO8lB,EAAkB9lB,KACzB2Z,EAASmM,EAAkBnM,OAC/B,IAAK,IAAIvoB,KAAO9F,EAAO,CACrB,IAAI06B,EAAa16B,EAAM8F,GACvB,GAAI40B,EAAY,CACd,IAAIngC,EAAO6/B,GAAiBM,EAAW5gB,kBACnCvf,IAASkgC,EAAOlgC,IAClBogC,GAAgB36B,EAAO8F,EAAK4O,EAAM2Z,KAM1C,SAASsM,GACP36B,EACA8F,EACA4O,EACAkmB,GAEA,IAAIC,EAAY76B,EAAM8F,IAClB+0B,GAAeD,GAAWC,EAAU36B,MAAQ06B,EAAQ16B,KACtD26B,EAAUzgB,kBAAkBiS,WAE9BrsB,EAAM8F,GAAO,KACbsM,EAAOsC,EAAM5O,GA/MfiyB,GAAUnJ,IACV4I,GAAW5I,IACXqC,GAAYrC,IACZoD,GAAepD,IACfD,GAAYC,IA8MZ,IAAIkM,GAAe,CAACvkC,OAAQ0M,OAAQjJ,OAEhC+gC,GAAY,CACdxgC,KAAM,aACNyyB,UAAU,EAEVtuB,MAAO,CACLs8B,QAASF,GACTG,QAASH,GACTlwB,IAAK,CAACrU,OAAQmO,SAGhBw2B,QAAS,WACPpjC,KAAKkI,MAAQzG,OAAO2Y,OAAO,MAC3Bpa,KAAK4c,KAAO,IAGdymB,UAAW,WACT,IAAK,IAAIr1B,KAAOhO,KAAKkI,MACnB26B,GAAgB7iC,KAAKkI,MAAO8F,EAAKhO,KAAK4c,OAI1C0mB,QAAS,WACP,IAAIhR,EAAStyB,KAEbA,KAAKy/B,OAAO,WAAW,SAAU13B,GAC/B06B,GAAWnQ,GAAQ,SAAU7vB,GAAQ,OAAO8/B,GAAQx6B,EAAKtF,SAE3DzC,KAAKy/B,OAAO,WAAW,SAAU13B,GAC/B06B,GAAWnQ,GAAQ,SAAU7vB,GAAQ,OAAQ8/B,GAAQx6B,EAAKtF,UAI9D8F,OAAQ,WACN,IAAIglB,EAAOvtB,KAAKuN,OAAOrG,QACnBoc,EAAQmV,GAAuBlL,GAC/BvL,EAAmBsB,GAASA,EAAMtB,iBACtC,GAAIA,EAAkB,CAEpB,IAAIvf,EAAO6/B,GAAiBtgB,GACxBiV,EAAMj3B,KACNkjC,EAAUjM,EAAIiM,QACdC,EAAUlM,EAAIkM,QAClB,GAEGD,KAAazgC,IAAS8/B,GAAQW,EAASzgC,KAEvC0gC,GAAW1gC,GAAQ8/B,GAAQY,EAAS1gC,GAErC,OAAO6gB,EAGT,IAAIigB,EAAQvjC,KACRkI,EAAQq7B,EAAMr7B,MACd0U,EAAO2mB,EAAM3mB,KACb5O,EAAmB,MAAbsV,EAAMtV,IAGZgU,EAAiB3B,KAAKsU,KAAO3S,EAAiB5Z,IAAO,KAAQ4Z,EAAoB,IAAK,IACtFsB,EAAMtV,IACN9F,EAAM8F,IACRsV,EAAMhB,kBAAoBpa,EAAM8F,GAAKsU,kBAErChI,EAAOsC,EAAM5O,GACb4O,EAAK9X,KAAKkJ,KAEV9F,EAAM8F,GAAOsV,EACb1G,EAAK9X,KAAKkJ,GAENhO,KAAK8S,KAAO8J,EAAK/d,OAAS2kC,SAASxjC,KAAK8S,MAC1C+vB,GAAgB36B,EAAO0U,EAAK,GAAIA,EAAM5c,KAAKu2B,SAI/CjT,EAAMre,KAAKuuB,WAAY,EAEzB,OAAOlQ,GAAUiK,GAAQA,EAAK,KAI9BkW,GAAoB,CACtBR,UAAWA,IAKb,SAASS,GAAe5M,GAEtB,IAAI6M,EAAY,CAChB,IAAgB,WAAc,OAAO3/B,IAQrCvC,OAAO6E,eAAewwB,EAAK,SAAU6M,GAKrC7M,EAAI8M,KAAO,CACT9iB,KAAMA,GACNjF,OAAQA,EACRsL,aAAcA,GACd0c,eAAgB9e,IAGlB+R,EAAIlW,IAAMA,GACVkW,EAAIgN,OAASte,GACbsR,EAAIxM,SAAWA,GAGfwM,EAAIiN,WAAa,SAAUzqB,GAEzB,OADAqL,GAAQrL,GACDA,GAGTwd,EAAI1kB,QAAU3Q,OAAO2Y,OAAO,MAC5B6C,EAAYxY,SAAQ,SAAUwC,GAC5B6vB,EAAI1kB,QAAQnL,EAAO,KAAOxF,OAAO2Y,OAAO,SAK1C0c,EAAI1kB,QAAQgV,MAAQ0P,EAEpBjb,EAAOib,EAAI1kB,QAAQ0uB,WAAY2C,IAE/BtC,GAAQrK,GACR2K,GAAY3K,GACZ6K,GAAW7K,GACXsL,GAAmBtL,GAGrB4M,GAAc5M,IAEdr1B,OAAO6E,eAAewwB,GAAI51B,UAAW,YAAa,CAChDqF,IAAKyZ,KAGPve,OAAO6E,eAAewwB,GAAI51B,UAAW,cAAe,CAClDqF,IAAK,WAEH,OAAOvG,KAAK+X,QAAU/X,KAAK+X,OAAOC,cAKtCvW,OAAO6E,eAAewwB,GAAK,0BAA2B,CACpDnuB,MAAOypB,KAGT0E,GAAIkN,QAAU,SAMd,IAAInmB,GAAiB5D,EAAQ,eAGzBgqB,GAAchqB,EAAQ,yCACtBgE,GAAc,SAAU7V,EAAKnB,EAAMi9B,GACrC,MACY,UAATA,GAAoBD,GAAY77B,IAAkB,WAATnB,GAChC,aAATi9B,GAA+B,WAAR97B,GACd,YAAT87B,GAA8B,UAAR97B,GACb,UAAT87B,GAA4B,UAAR97B,GAIrB+7B,GAAmBlqB,EAAQ,wCAE3BmqB,GAA8BnqB,EAAQ,sCAEtCoqB,GAAyB,SAAUr2B,EAAKrF,GAC1C,OAAO27B,GAAiB37B,IAAoB,UAAVA,EAC9B,QAEQ,oBAARqF,GAA6Bo2B,GAA4Bz7B,GACvDA,EACA,QAGJ47B,GAAgBtqB,EAClB,wYAQEuqB,GAAU,+BAEVC,GAAU,SAAUhiC,GACtB,MAA0B,MAAnBA,EAAK0D,OAAO,IAAmC,UAArB1D,EAAKrC,MAAM,EAAG,IAG7CskC,GAAe,SAAUjiC,GAC3B,OAAOgiC,GAAQhiC,GAAQA,EAAKrC,MAAM,EAAGqC,EAAK5D,QAAU,IAGlDylC,GAAmB,SAAUv8B,GAC/B,OAAc,MAAPA,IAAuB,IAARA,GAKxB,SAAS48B,GAAkBrhB,GACzB,IAAIre,EAAOqe,EAAMre,KACb2/B,EAAathB,EACbuhB,EAAYvhB,EAChB,MAAOpK,EAAM2rB,EAAUviB,mBACrBuiB,EAAYA,EAAUviB,kBAAkBiU,OACpCsO,GAAaA,EAAU5/B,OACzBA,EAAO6/B,GAAeD,EAAU5/B,KAAMA,IAG1C,MAAOiU,EAAM0rB,EAAaA,EAAW3sB,QAC/B2sB,GAAcA,EAAW3/B,OAC3BA,EAAO6/B,GAAe7/B,EAAM2/B,EAAW3/B,OAG3C,OAAO8/B,GAAY9/B,EAAK4D,YAAa5D,EAAK6D,OAG5C,SAASg8B,GAAgB9hB,EAAO/K,GAC9B,MAAO,CACLpP,YAAa5H,GAAO+hB,EAAMna,YAAaoP,EAAOpP,aAC9CC,MAAOoQ,EAAM8J,EAAMla,OACf,CAACka,EAAMla,MAAOmP,EAAOnP,OACrBmP,EAAOnP,OAIf,SAASi8B,GACPl8B,EACAm8B,GAEA,OAAI9rB,EAAMrQ,IAAgBqQ,EAAM8rB,GACvB/jC,GAAO4H,EAAao8B,GAAeD,IAGrC,GAGT,SAAS/jC,GAAQjC,EAAGC,GAClB,OAAOD,EAAIC,EAAKD,EAAI,IAAMC,EAAKD,EAAKC,GAAK,GAG3C,SAASgmC,GAAgBt8B,GACvB,OAAIzG,MAAM4X,QAAQnR,GACTu8B,GAAev8B,GAEpBxI,EAASwI,GACJw8B,GAAgBx8B,GAEJ,kBAAVA,EACFA,EAGF,GAGT,SAASu8B,GAAgBv8B,GAGvB,IAFA,IACIy8B,EADA55B,EAAM,GAED7K,EAAI,EAAG4a,EAAI5S,EAAM9J,OAAQ8B,EAAI4a,EAAG5a,IACnCuY,EAAMksB,EAAcH,GAAet8B,EAAMhI,MAAwB,KAAhBykC,IAC/C55B,IAAOA,GAAO,KAClBA,GAAO45B,GAGX,OAAO55B,EAGT,SAAS25B,GAAiBx8B,GACxB,IAAI6C,EAAM,GACV,IAAK,IAAIwC,KAAOrF,EACVA,EAAMqF,KACJxC,IAAOA,GAAO,KAClBA,GAAOwC,GAGX,OAAOxC,EAKT,IAAI65B,GAAe,CACjBC,IAAK,6BACLC,KAAM,sCAGJC,GAAYvrB,EACd,snBAeEwrB,GAAQxrB,EACV,kNAGA,GAGE2D,GAAgB,SAAUxV,GAC5B,OAAOo9B,GAAUp9B,IAAQq9B,GAAMr9B,IAGjC,SAAS2V,GAAiB3V,GACxB,OAAIq9B,GAAMr9B,GACD,MAIG,SAARA,EACK,YADT,EAKF,IAAIs9B,GAAsBjkC,OAAO2Y,OAAO,MACxC,SAAS0D,GAAkB1V,GAEzB,IAAK2W,EACH,OAAO,EAET,GAAInB,GAAcxV,GAChB,OAAO,EAIT,GAFAA,EAAMA,EAAIhE,cAEsB,MAA5BshC,GAAoBt9B,GACtB,OAAOs9B,GAAoBt9B,GAE7B,IAAI0yB,EAAK3Q,SAAS9jB,cAAc+B,GAChC,OAAIA,EAAIoO,QAAQ,MAAQ,EAEdkvB,GAAoBt9B,GAC1B0yB,EAAGt4B,cAAgBhB,OAAOmkC,oBAC1B7K,EAAGt4B,cAAgBhB,OAAOokC,YAGpBF,GAAoBt9B,GAAO,qBAAqB9J,KAAKw8B,EAAGx5B,YAIpE,IAAIukC,GAAkB5rB,EAAQ,6CAO9B,SAAS6rB,GAAOhL,GACd,GAAkB,kBAAPA,EAAiB,CAC1B,IAAIiL,EAAW5b,SAAS6b,cAAclL,GACtC,OAAKiL,GAII5b,SAAS9jB,cAAc,OAIhC,OAAOy0B,EAMX,SAASmL,GAAiBC,EAAS5iB,GACjC,IAAIvB,EAAMoI,SAAS9jB,cAAc6/B,GACjC,MAAgB,WAAZA,GAIA5iB,EAAMre,MAAQqe,EAAMre,KAAKiJ,YAAuCpP,IAA9BwkB,EAAMre,KAAKiJ,MAAMi4B,UACrDpkB,EAAIqkB,aAAa,WAAY,YAJtBrkB,EASX,SAASskB,GAAiBC,EAAWJ,GACnC,OAAO/b,SAASkc,gBAAgBhB,GAAaiB,GAAYJ,GAG3D,SAAS9b,GAAgB5c,GACvB,OAAO2c,SAASC,eAAe5c,GAGjC,SAAS+4B,GAAe/4B,GACtB,OAAO2c,SAASoc,cAAc/4B,GAGhC,SAASg5B,GAAc5B,EAAY6B,EAASC,GAC1C9B,EAAW4B,aAAaC,EAASC,GAGnC,SAASC,GAAaxjB,EAAMH,GAC1BG,EAAKwjB,YAAY3jB,GAGnB,SAAS4jB,GAAazjB,EAAMH,GAC1BG,EAAKyjB,YAAY5jB,GAGnB,SAAS4hB,GAAYzhB,GACnB,OAAOA,EAAKyhB,WAGd,SAASiC,GAAa1jB,GACpB,OAAOA,EAAK0jB,YAGd,SAASX,GAAS/iB,GAChB,OAAOA,EAAK+iB,QAGd,SAASY,GAAgB3jB,EAAM3V,GAC7B2V,EAAK4jB,YAAcv5B,EAGrB,SAASw5B,GAAe7jB,EAAM3L,GAC5B2L,EAAKijB,aAAa5uB,EAAS,IAG7B,IAAIyvB,GAAuBxlC,OAAOsX,OAAO,CACvC1S,cAAe4/B,GACfI,gBAAiBA,GACjBjc,eAAgBA,GAChBmc,cAAeA,GACfC,aAAcA,GACdG,YAAaA,GACbC,YAAaA,GACbhC,WAAYA,GACZiC,YAAaA,GACbX,QAASA,GACTY,eAAgBA,GAChBE,cAAeA,KAKb/P,GAAM,CACR7c,OAAQ,SAAiBW,EAAGuI,GAC1B4jB,GAAY5jB,IAEd7B,OAAQ,SAAiBqS,EAAUxQ,GAC7BwQ,EAAS7uB,KAAKgyB,MAAQ3T,EAAMre,KAAKgyB,MACnCiQ,GAAYpT,GAAU,GACtBoT,GAAY5jB,KAGhB+Q,QAAS,SAAkB/Q,GACzB4jB,GAAY5jB,GAAO,KAIvB,SAAS4jB,GAAa5jB,EAAO6jB,GAC3B,IAAIn5B,EAAMsV,EAAMre,KAAKgyB,IACrB,GAAK/d,EAAMlL,GAAX,CAEA,IAAIiY,EAAK3C,EAAMxL,QACXmf,EAAM3T,EAAMhB,mBAAqBgB,EAAMvB,IACvCqlB,EAAOnhB,EAAG4T,MACVsN,EACEjlC,MAAM4X,QAAQstB,EAAKp5B,IACrBsM,EAAO8sB,EAAKp5B,GAAMipB,GACTmQ,EAAKp5B,KAASipB,IACvBmQ,EAAKp5B,QAAOlP,GAGVwkB,EAAMre,KAAKoiC,SACRnlC,MAAM4X,QAAQstB,EAAKp5B,IAEbo5B,EAAKp5B,GAAKwI,QAAQygB,GAAO,GAElCmQ,EAAKp5B,GAAKlJ,KAAKmyB,GAHfmQ,EAAKp5B,GAAO,CAACipB,GAMfmQ,EAAKp5B,GAAOipB,GAiBlB,IAAIqQ,GAAY,IAAIxlB,GAAM,GAAI,GAAI,IAE9BwE,GAAQ,CAAC,SAAU,WAAY,SAAU,SAAU,WAEvD,SAASihB,GAAWvoC,EAAGC,GACrB,OACED,EAAEgP,MAAQ/O,EAAE+O,MAERhP,EAAEoJ,MAAQnJ,EAAEmJ,KACZpJ,EAAE0jB,YAAczjB,EAAEyjB,WAClBxJ,EAAMla,EAAEiG,QAAUiU,EAAMja,EAAEgG,OAC1BuiC,GAAcxoC,EAAGC,IAEjBka,EAAOna,EAAE8jB,qBACT9jB,EAAEijB,eAAiBhjB,EAAEgjB,cACrBjJ,EAAQ/Z,EAAEgjB,aAAapgB,QAM/B,SAAS2lC,GAAexoC,EAAGC,GACzB,GAAc,UAAVD,EAAEoJ,IAAmB,OAAO,EAChC,IAAIzH,EACA8mC,EAAQvuB,EAAMvY,EAAI3B,EAAEiG,OAASiU,EAAMvY,EAAIA,EAAEuN,QAAUvN,EAAEsG,KACrDygC,EAAQxuB,EAAMvY,EAAI1B,EAAEgG,OAASiU,EAAMvY,EAAIA,EAAEuN,QAAUvN,EAAEsG,KACzD,OAAOwgC,IAAUC,GAAS7B,GAAgB4B,IAAU5B,GAAgB6B,GAGtE,SAASC,GAAmBn/B,EAAUo/B,EAAUC,GAC9C,IAAIlnC,EAAGqN,EACHmM,EAAM,GACV,IAAKxZ,EAAIinC,EAAUjnC,GAAKknC,IAAUlnC,EAChCqN,EAAMxF,EAAS7H,GAAGqN,IACdkL,EAAMlL,KAAQmM,EAAInM,GAAOrN,GAE/B,OAAOwZ,EAGT,SAAS2tB,GAAqBC,GAC5B,IAAIpnC,EAAGm7B,EACHvC,EAAM,GAENyO,EAAUD,EAAQC,QAClBf,EAAUc,EAAQd,QAEtB,IAAKtmC,EAAI,EAAGA,EAAI2lB,GAAMznB,SAAU8B,EAE9B,IADA44B,EAAIjT,GAAM3lB,IAAM,GACXm7B,EAAI,EAAGA,EAAIkM,EAAQnpC,SAAUi9B,EAC5B5iB,EAAM8uB,EAAQlM,GAAGxV,GAAM3lB,MACzB44B,EAAIjT,GAAM3lB,IAAImE,KAAKkjC,EAAQlM,GAAGxV,GAAM3lB,KAK1C,SAASsnC,EAAalmB,GACpB,OAAO,IAAID,GAAMmlB,EAAQf,QAAQnkB,GAAK3d,cAAe,GAAI,QAAItF,EAAWijB,GAG1E,SAASmmB,EAAYC,EAAUzV,GAC7B,SAASjH,IACuB,MAAxBA,EAAUiH,WACd0V,EAAWD,GAIf,OADA1c,EAAUiH,UAAYA,EACfjH,EAGT,SAAS2c,EAAYtN,GACnB,IAAI7iB,EAASgvB,EAAQrC,WAAW9J,GAE5B5hB,EAAMjB,IACRgvB,EAAQN,YAAY1uB,EAAQ6iB,GAsBhC,SAASuN,EACP/kB,EACAglB,EACAC,EACAC,EACAC,EACAC,EACAr9B,GAYA,GAVI6N,EAAMoK,EAAMvB,MAAQ7I,EAAMwvB,KAM5BplB,EAAQolB,EAAWr9B,GAASgY,GAAWC,IAGzCA,EAAMb,cAAgBgmB,GAClBhU,EAAgBnR,EAAOglB,EAAoBC,EAAWC,GAA1D,CAIA,IAAIvjC,EAAOqe,EAAMre,KACbuD,EAAW8a,EAAM9a,SACjBJ,EAAMkb,EAAMlb,IACZ8Q,EAAM9Q,IAeRkb,EAAMvB,IAAMuB,EAAMpB,GACd+kB,EAAQZ,gBAAgB/iB,EAAMpB,GAAI9Z,GAClC6+B,EAAQ5gC,cAAc+B,EAAKkb,GAC/BqlB,EAASrlB,GAIPslB,EAAetlB,EAAO9a,EAAU8/B,GAC5BpvB,EAAMjU,IACR4jC,EAAkBvlB,EAAOglB,GAE3BtU,EAAOuU,EAAWjlB,EAAMvB,IAAKymB,IAMtBrvB,EAAOmK,EAAMZ,YACtBY,EAAMvB,IAAMklB,EAAQV,cAAcjjB,EAAM9V,MACxCwmB,EAAOuU,EAAWjlB,EAAMvB,IAAKymB,KAE7BllB,EAAMvB,IAAMklB,EAAQ7c,eAAe9G,EAAM9V,MACzCwmB,EAAOuU,EAAWjlB,EAAMvB,IAAKymB,KAIjC,SAAS/T,EAAiBnR,EAAOglB,EAAoBC,EAAWC,GAC9D,IAAI7nC,EAAI2iB,EAAMre,KACd,GAAIiU,EAAMvY,GAAI,CACZ,IAAImoC,EAAgB5vB,EAAMoK,EAAMhB,oBAAsB3hB,EAAE6yB,UAQxD,GAPIta,EAAMvY,EAAIA,EAAEgX,OAASuB,EAAMvY,EAAIA,EAAE0yB,OACnC1yB,EAAE2iB,GAAO,GAMPpK,EAAMoK,EAAMhB,mBAMd,OALAymB,EAAczlB,EAAOglB,GACrBtU,EAAOuU,EAAWjlB,EAAMvB,IAAKymB,GACzBrvB,EAAO2vB,IACTE,EAAoB1lB,EAAOglB,EAAoBC,EAAWC,IAErD,GAKb,SAASO,EAAezlB,EAAOglB,GACzBpvB,EAAMoK,EAAMre,KAAKgkC,iBACnBX,EAAmBxjC,KAAK3F,MAAMmpC,EAAoBhlB,EAAMre,KAAKgkC,eAC7D3lB,EAAMre,KAAKgkC,cAAgB,MAE7B3lB,EAAMvB,IAAMuB,EAAMhB,kBAAkB+X,IAChC6O,EAAY5lB,IACdulB,EAAkBvlB,EAAOglB,GACzBK,EAASrlB,KAIT4jB,GAAY5jB,GAEZglB,EAAmBxjC,KAAKwe,IAI5B,SAAS0lB,EAAqB1lB,EAAOglB,EAAoBC,EAAWC,GAClE,IAAI7nC,EAKAwoC,EAAY7lB,EAChB,MAAO6lB,EAAU7mB,kBAEf,GADA6mB,EAAYA,EAAU7mB,kBAAkBiU,OACpCrd,EAAMvY,EAAIwoC,EAAUlkC,OAASiU,EAAMvY,EAAIA,EAAEyoC,YAAa,CACxD,IAAKzoC,EAAI,EAAGA,EAAI44B,EAAI8P,SAASxqC,SAAU8B,EACrC44B,EAAI8P,SAAS1oC,GAAG2mC,GAAW6B,GAE7Bb,EAAmBxjC,KAAKqkC,GACxB,MAKJnV,EAAOuU,EAAWjlB,EAAMvB,IAAKymB,GAG/B,SAASxU,EAAQ/b,EAAQ8J,EAAKunB,GACxBpwB,EAAMjB,KACJiB,EAAMowB,GACJrC,EAAQrC,WAAW0E,KAAYrxB,GACjCgvB,EAAQT,aAAavuB,EAAQ8J,EAAKunB,GAGpCrC,EAAQL,YAAY3uB,EAAQ8J,IAKlC,SAAS6mB,EAAgBtlB,EAAO9a,EAAU8/B,GACxC,GAAIpmC,MAAM4X,QAAQtR,GAAW,CACvB,EAGJ,IAAK,IAAI7H,EAAI,EAAGA,EAAI6H,EAAS3J,SAAU8B,EACrC0nC,EAAU7/B,EAAS7H,GAAI2nC,EAAoBhlB,EAAMvB,IAAK,MAAM,EAAMvZ,EAAU7H,QAErE0Y,EAAYiK,EAAM9V,OAC3By5B,EAAQL,YAAYtjB,EAAMvB,IAAKklB,EAAQ7c,eAAe3rB,OAAO6kB,EAAM9V,QAIvE,SAAS07B,EAAa5lB,GACpB,MAAOA,EAAMhB,kBACXgB,EAAQA,EAAMhB,kBAAkBiU,OAElC,OAAOrd,EAAMoK,EAAMlb,KAGrB,SAASygC,EAAmBvlB,EAAOglB,GACjC,IAAK,IAAIhP,EAAM,EAAGA,EAAMC,EAAInf,OAAOvb,SAAUy6B,EAC3CC,EAAInf,OAAOkf,GAAKgO,GAAWhkB,GAE7B3iB,EAAI2iB,EAAMre,KAAK0S,KACXuB,EAAMvY,KACJuY,EAAMvY,EAAEyZ,SAAWzZ,EAAEyZ,OAAOktB,GAAWhkB,GACvCpK,EAAMvY,EAAEqzB,SAAWsU,EAAmBxjC,KAAKwe,IAOnD,SAASqlB,EAAUrlB,GACjB,IAAI3iB,EACJ,GAAIuY,EAAMvY,EAAI2iB,EAAMjB,WAClB4kB,EAAQD,cAAc1jB,EAAMvB,IAAKphB,OAC5B,CACL,IAAI4oC,EAAWjmB,EACf,MAAOimB,EACDrwB,EAAMvY,EAAI4oC,EAASzxB,UAAYoB,EAAMvY,EAAIA,EAAE4X,SAASV,WACtDovB,EAAQD,cAAc1jB,EAAMvB,IAAKphB,GAEnC4oC,EAAWA,EAAStxB,OAIpBiB,EAAMvY,EAAIizB,KACZjzB,IAAM2iB,EAAMxL,SACZnX,IAAM2iB,EAAMnB,WACZjJ,EAAMvY,EAAIA,EAAE4X,SAASV,WAErBovB,EAAQD,cAAc1jB,EAAMvB,IAAKphB,GAIrC,SAAS6oC,EAAWjB,EAAWC,EAAQtV,EAAQuW,EAAU5B,EAAQS,GAC/D,KAAOmB,GAAY5B,IAAU4B,EAC3BpB,EAAUnV,EAAOuW,GAAWnB,EAAoBC,EAAWC,GAAQ,EAAOtV,EAAQuW,GAItF,SAASC,EAAmBpmB,GAC1B,IAAI3iB,EAAGm7B,EACH72B,EAAOqe,EAAMre,KACjB,GAAIiU,EAAMjU,GAER,IADIiU,EAAMvY,EAAIsE,EAAK0S,OAASuB,EAAMvY,EAAIA,EAAE0zB,UAAY1zB,EAAE2iB,GACjD3iB,EAAI,EAAGA,EAAI44B,EAAIlF,QAAQx1B,SAAU8B,EAAK44B,EAAIlF,QAAQ1zB,GAAG2iB,GAE5D,GAAIpK,EAAMvY,EAAI2iB,EAAM9a,UAClB,IAAKszB,EAAI,EAAGA,EAAIxY,EAAM9a,SAAS3J,SAAUi9B,EACvC4N,EAAkBpmB,EAAM9a,SAASszB,IAKvC,SAAS6N,EAAczW,EAAQuW,EAAU5B,GACvC,KAAO4B,GAAY5B,IAAU4B,EAAU,CACrC,IAAIxjC,EAAKitB,EAAOuW,GACZvwB,EAAMjT,KACJiT,EAAMjT,EAAGmC,MACXwhC,EAA0B3jC,GAC1ByjC,EAAkBzjC,IAElBmiC,EAAWniC,EAAG8b,OAMtB,SAAS6nB,EAA2BtmB,EAAOumB,GACzC,GAAI3wB,EAAM2wB,IAAO3wB,EAAMoK,EAAMre,MAAO,CAClC,IAAItE,EACA+xB,EAAY6G,EAAIjf,OAAOzb,OAAS,EAapC,IAZIqa,EAAM2wB,GAGRA,EAAGnX,WAAaA,EAGhBmX,EAAK3B,EAAW5kB,EAAMvB,IAAK2Q,GAGzBxZ,EAAMvY,EAAI2iB,EAAMhB,oBAAsBpJ,EAAMvY,EAAIA,EAAE41B,SAAWrd,EAAMvY,EAAEsE,OACvE2kC,EAA0BjpC,EAAGkpC,GAE1BlpC,EAAI,EAAGA,EAAI44B,EAAIjf,OAAOzb,SAAU8B,EACnC44B,EAAIjf,OAAO3Z,GAAG2iB,EAAOumB,GAEnB3wB,EAAMvY,EAAI2iB,EAAMre,KAAK0S,OAASuB,EAAMvY,EAAIA,EAAE2Z,QAC5C3Z,EAAE2iB,EAAOumB,GAETA,SAGFzB,EAAW9kB,EAAMvB,KAIrB,SAAS+nB,EAAgBvB,EAAWwB,EAAOC,EAAO1B,EAAoB2B,GACpE,IAQIC,EAAaC,EAAUC,EAAa5B,EARpC6B,EAAc,EACdC,EAAc,EACdC,EAAYR,EAAMlrC,OAAS,EAC3B2rC,EAAgBT,EAAM,GACtBU,EAAcV,EAAMQ,GACpBG,EAAYV,EAAMnrC,OAAS,EAC3B8rC,EAAgBX,EAAM,GACtBY,EAAcZ,EAAMU,GAMpBG,GAAWZ,EAMf,MAAOI,GAAeE,GAAaD,GAAeI,EAC5C1xB,EAAQwxB,GACVA,EAAgBT,IAAQM,GACfrxB,EAAQyxB,GACjBA,EAAcV,IAAQQ,GACbhD,GAAUiD,EAAeG,IAClCG,EAAWN,EAAeG,EAAerC,EAAoB0B,EAAOM,GACpEE,EAAgBT,IAAQM,GACxBM,EAAgBX,IAAQM,IACf/C,GAAUkD,EAAaG,IAChCE,EAAWL,EAAaG,EAAatC,EAAoB0B,EAAOU,GAChED,EAAcV,IAAQQ,GACtBK,EAAcZ,IAAQU,IACbnD,GAAUiD,EAAeI,IAClCE,EAAWN,EAAeI,EAAatC,EAAoB0B,EAAOU,GAClEG,GAAW5D,EAAQT,aAAa+B,EAAWiC,EAAczoB,IAAKklB,EAAQJ,YAAY4D,EAAY1oB,MAC9FyoB,EAAgBT,IAAQM,GACxBO,EAAcZ,IAAQU,IACbnD,GAAUkD,EAAaE,IAChCG,EAAWL,EAAaE,EAAerC,EAAoB0B,EAAOM,GAClEO,GAAW5D,EAAQT,aAAa+B,EAAWkC,EAAY1oB,IAAKyoB,EAAczoB,KAC1E0oB,EAAcV,IAAQQ,GACtBI,EAAgBX,IAAQM,KAEpBtxB,EAAQkxB,KAAgBA,EAAcvC,GAAkBoC,EAAOM,EAAaE,IAChFJ,EAAWjxB,EAAMyxB,EAAc38B,KAC3Bk8B,EAAYS,EAAc38B,KAC1B+8B,EAAaJ,EAAeZ,EAAOM,EAAaE,GAChDvxB,EAAQmxB,GACV9B,EAAUsC,EAAerC,EAAoBC,EAAWiC,EAAczoB,KAAK,EAAOioB,EAAOM,IAEzFF,EAAcL,EAAMI,GAChB5C,GAAU6C,EAAaO,IACzBG,EAAWV,EAAaO,EAAerC,EAAoB0B,EAAOM,GAClEP,EAAMI,QAAYrrC,EAClB+rC,GAAW5D,EAAQT,aAAa+B,EAAW6B,EAAYroB,IAAKyoB,EAAczoB,MAG1EsmB,EAAUsC,EAAerC,EAAoBC,EAAWiC,EAAczoB,KAAK,EAAOioB,EAAOM,IAG7FK,EAAgBX,IAAQM,IAGxBD,EAAcE,GAChB/B,EAASxvB,EAAQgxB,EAAMU,EAAY,IAAM,KAAOV,EAAMU,EAAY,GAAG3oB,IACrEynB,EAAUjB,EAAWC,EAAQwB,EAAOM,EAAaI,EAAWpC,IACnDgC,EAAcI,GACvBf,EAAaI,EAAOM,EAAaE,GAsBrC,SAASQ,EAAc5nB,EAAM4mB,EAAOpuB,EAAOqvB,GACzC,IAAK,IAAIrqC,EAAIgb,EAAOhb,EAAIqqC,EAAKrqC,IAAK,CAChC,IAAIzB,EAAI6qC,EAAMppC,GACd,GAAIuY,EAAMha,IAAMqoC,GAAUpkB,EAAMjkB,GAAM,OAAOyB,GAIjD,SAASmqC,EACPhX,EACAxQ,EACAglB,EACAI,EACAr9B,EACA4+B,GAEA,GAAInW,IAAaxQ,EAAjB,CAIIpK,EAAMoK,EAAMvB,MAAQ7I,EAAMwvB,KAE5BplB,EAAQolB,EAAWr9B,GAASgY,GAAWC,IAGzC,IAAIvB,EAAMuB,EAAMvB,IAAM+R,EAAS/R,IAE/B,GAAI5I,EAAO2a,EAAShR,oBACd5J,EAAMoK,EAAMrB,aAAawV,UAC3BwT,EAAQnX,EAAS/R,IAAKuB,EAAOglB,GAE7BhlB,EAAMR,oBAAqB,OAS/B,GAAI3J,EAAOmK,EAAMd,WACfrJ,EAAO2a,EAAStR,WAChBc,EAAMtV,MAAQ8lB,EAAS9lB,MACtBmL,EAAOmK,EAAMX,WAAaxJ,EAAOmK,EAAMV,SAExCU,EAAMhB,kBAAoBwR,EAASxR,sBALrC,CASA,IAAI3hB,EACAsE,EAAOqe,EAAMre,KACbiU,EAAMjU,IAASiU,EAAMvY,EAAIsE,EAAK0S,OAASuB,EAAMvY,EAAIA,EAAE+yB,WACrD/yB,EAAEmzB,EAAUxQ,GAGd,IAAIymB,EAAQjW,EAAStrB,SACjBvC,EAAKqd,EAAM9a,SACf,GAAI0Q,EAAMjU,IAASikC,EAAY5lB,GAAQ,CACrC,IAAK3iB,EAAI,EAAGA,EAAI44B,EAAI9X,OAAO5iB,SAAU8B,EAAK44B,EAAI9X,OAAO9gB,GAAGmzB,EAAUxQ,GAC9DpK,EAAMvY,EAAIsE,EAAK0S,OAASuB,EAAMvY,EAAIA,EAAE8gB,SAAW9gB,EAAEmzB,EAAUxQ,GAE7DtK,EAAQsK,EAAM9V,MACZ0L,EAAM6wB,IAAU7wB,EAAMjT,GACpB8jC,IAAU9jC,GAAM6jC,EAAe/nB,EAAKgoB,EAAO9jC,EAAIqiC,EAAoB2B,GAC9D/wB,EAAMjT,IAIXiT,EAAM4a,EAAStmB,OAASy5B,EAAQH,eAAe/kB,EAAK,IACxDynB,EAAUznB,EAAK,KAAM9b,EAAI,EAAGA,EAAGpH,OAAS,EAAGypC,IAClCpvB,EAAM6wB,GACfJ,EAAaI,EAAO,EAAGA,EAAMlrC,OAAS,GAC7Bqa,EAAM4a,EAAStmB,OACxBy5B,EAAQH,eAAe/kB,EAAK,IAErB+R,EAAStmB,OAAS8V,EAAM9V,MACjCy5B,EAAQH,eAAe/kB,EAAKuB,EAAM9V,MAEhC0L,EAAMjU,IACJiU,EAAMvY,EAAIsE,EAAK0S,OAASuB,EAAMvY,EAAIA,EAAEuqC,YAAcvqC,EAAEmzB,EAAUxQ,KAItE,SAAS6nB,EAAkB7nB,EAAOyY,EAAOqP,GAGvC,GAAIjyB,EAAOiyB,IAAYlyB,EAAMoK,EAAMrL,QACjCqL,EAAMrL,OAAOhT,KAAKgkC,cAAgBlN,OAElC,IAAK,IAAIp7B,EAAI,EAAGA,EAAIo7B,EAAMl9B,SAAU8B,EAClCo7B,EAAMp7B,GAAGsE,KAAK0S,KAAKqc,OAAO+H,EAAMp7B,IAKtC,IAKI0qC,EAAmBpxB,EAAQ,2CAG/B,SAASgxB,EAASlpB,EAAKuB,EAAOglB,EAAoBgD,GAChD,IAAI3qC,EACAyH,EAAMkb,EAAMlb,IACZnD,EAAOqe,EAAMre,KACbuD,EAAW8a,EAAM9a,SAIrB,GAHA8iC,EAASA,GAAWrmC,GAAQA,EAAKixB,IACjC5S,EAAMvB,IAAMA,EAER5I,EAAOmK,EAAMZ,YAAcxJ,EAAMoK,EAAMrB,cAEzC,OADAqB,EAAMR,oBAAqB,GACpB,EAQT,GAAI5J,EAAMjU,KACJiU,EAAMvY,EAAIsE,EAAK0S,OAASuB,EAAMvY,EAAIA,EAAE0yB,OAAS1yB,EAAE2iB,GAAO,GACtDpK,EAAMvY,EAAI2iB,EAAMhB,oBAGlB,OADAymB,EAAczlB,EAAOglB,IACd,EAGX,GAAIpvB,EAAM9Q,GAAM,CACd,GAAI8Q,EAAM1Q,GAER,GAAKuZ,EAAIwpB,gBAIP,GAAIryB,EAAMvY,EAAIsE,IAASiU,EAAMvY,EAAIA,EAAEkvB,WAAa3W,EAAMvY,EAAIA,EAAE6qC,YAC1D,GAAI7qC,IAAMohB,EAAIypB,UAWZ,OAAO,MAEJ,CAIL,IAFA,IAAIC,GAAgB,EAChB5G,EAAY9iB,EAAI2pB,WACXpS,EAAM,EAAGA,EAAM9wB,EAAS3J,OAAQy6B,IAAO,CAC9C,IAAKuL,IAAcoG,EAAQpG,EAAWr8B,EAAS8wB,GAAMgP,EAAoBgD,GAAS,CAChFG,GAAgB,EAChB,MAEF5G,EAAYA,EAAUgC,YAIxB,IAAK4E,GAAiB5G,EAUpB,OAAO,OAxCX+D,EAAetlB,EAAO9a,EAAU8/B,GA6CpC,GAAIpvB,EAAMjU,GAAO,CACf,IAAI0mC,GAAa,EACjB,IAAK,IAAI39B,KAAO/I,EACd,IAAKomC,EAAiBr9B,GAAM,CAC1B29B,GAAa,EACb9C,EAAkBvlB,EAAOglB,GACzB,OAGCqD,GAAc1mC,EAAK,UAEtBylB,GAASzlB,EAAK,gBAGT8c,EAAI9c,OAASqe,EAAM9V,OAC5BuU,EAAI9c,KAAOqe,EAAM9V,MAEnB,OAAO,EAcT,OAAO,SAAgBsmB,EAAUxQ,EAAOgQ,EAAW2W,GACjD,IAAIjxB,EAAQsK,GAAZ,CAKA,IAAIsoB,GAAiB,EACjBtD,EAAqB,GAEzB,GAAItvB,EAAQ8a,GAEV8X,GAAiB,EACjBvD,EAAU/kB,EAAOglB,OACZ,CACL,IAAIuD,EAAgB3yB,EAAM4a,EAASgY,UACnC,IAAKD,GAAiBtE,GAAUzT,EAAUxQ,GAExCwnB,EAAWhX,EAAUxQ,EAAOglB,EAAoB,KAAM,KAAM2B,OACvD,CACL,GAAI4B,EAAe,CAQjB,GAJ0B,IAAtB/X,EAASgY,UAAkBhY,EAASiY,aAAa/uB,KACnD8W,EAASkY,gBAAgBhvB,GACzBsW,GAAY,GAEVna,EAAOma,IACL2X,EAAQnX,EAAUxQ,EAAOglB,GAE3B,OADA6C,EAAiB7nB,EAAOglB,GAAoB,GACrCxU,EAaXA,EAAWmU,EAAYnU,GAIzB,IAAImY,EAASnY,EAAS/R,IAClBwmB,EAAYtB,EAAQrC,WAAWqH,GAcnC,GAXA5D,EACE/kB,EACAglB,EAIA2D,EAAOC,SAAW,KAAO3D,EACzBtB,EAAQJ,YAAYoF,IAIlB/yB,EAAMoK,EAAMrL,QAAS,CACvB,IAAIsxB,EAAWjmB,EAAMrL,OACjBk0B,EAAYjD,EAAY5lB,GAC5B,MAAOimB,EAAU,CACf,IAAK,IAAI5oC,EAAI,EAAGA,EAAI44B,EAAIlF,QAAQx1B,SAAU8B,EACxC44B,EAAIlF,QAAQ1zB,GAAG4oC,GAGjB,GADAA,EAASxnB,IAAMuB,EAAMvB,IACjBoqB,EAAW,CACb,IAAK,IAAI7S,EAAM,EAAGA,EAAMC,EAAInf,OAAOvb,SAAUy6B,EAC3CC,EAAInf,OAAOkf,GAAKgO,GAAWiC,GAK7B,IAAIvV,EAASuV,EAAStkC,KAAK0S,KAAKqc,OAChC,GAAIA,EAAO9H,OAET,IAAK,IAAIkgB,EAAM,EAAGA,EAAMpY,EAAO5I,IAAIvsB,OAAQutC,IACzCpY,EAAO5I,IAAIghB,UAIflF,GAAYqC,GAEdA,EAAWA,EAAStxB,QAKpBiB,EAAMqvB,GACRoB,EAAa,CAAC7V,GAAW,EAAG,GACnB5a,EAAM4a,EAAS1rB,MACxBshC,EAAkB5V,IAMxB,OADAqX,EAAiB7nB,EAAOglB,EAAoBsD,GACrCtoB,EAAMvB,IAnGP7I,EAAM4a,IAAa4V,EAAkB5V,IAyG/C,IAAI7M,GAAa,CACf7M,OAAQiyB,GACR5qB,OAAQ4qB,GACRhY,QAAS,SAA2B/Q,GAClC+oB,GAAiB/oB,EAAOgkB,MAI5B,SAAS+E,GAAkBvY,EAAUxQ,IAC/BwQ,EAAS7uB,KAAKgiB,YAAc3D,EAAMre,KAAKgiB,aACzCkT,GAAQrG,EAAUxQ,GAItB,SAAS6W,GAASrG,EAAUxQ,GAC1B,IAQItV,EAAKs+B,EAAQC,EARbC,EAAW1Y,IAAawT,GACxBmF,EAAYnpB,IAAUgkB,GACtBoF,EAAUC,GAAsB7Y,EAAS7uB,KAAKgiB,WAAY6M,EAAShc,SACnE80B,EAAUD,GAAsBrpB,EAAMre,KAAKgiB,WAAY3D,EAAMxL,SAE7D+0B,EAAiB,GACjBC,EAAoB,GAGxB,IAAK9+B,KAAO4+B,EACVN,EAASI,EAAQ1+B,GACjBu+B,EAAMK,EAAQ5+B,GACTs+B,GAQHC,EAAIrO,SAAWoO,EAAO3jC,MACtB4jC,EAAIQ,OAAST,EAAOU,IACpBC,GAAWV,EAAK,SAAUjpB,EAAOwQ,GAC7ByY,EAAIzlC,KAAOylC,EAAIzlC,IAAIomC,kBACrBJ,EAAkBhoC,KAAKynC,KAVzBU,GAAWV,EAAK,OAAQjpB,EAAOwQ,GAC3ByY,EAAIzlC,KAAOylC,EAAIzlC,IAAI8c,UACrBipB,EAAe/nC,KAAKynC,IAa1B,GAAIM,EAAehuC,OAAQ,CACzB,IAAIsuC,EAAa,WACf,IAAK,IAAIxsC,EAAI,EAAGA,EAAIksC,EAAehuC,OAAQ8B,IACzCssC,GAAWJ,EAAelsC,GAAI,WAAY2iB,EAAOwQ,IAGjD0Y,EACF1gB,GAAexI,EAAO,SAAU6pB,GAEhCA,IAYJ,GARIL,EAAkBjuC,QACpBitB,GAAexI,EAAO,aAAa,WACjC,IAAK,IAAI3iB,EAAI,EAAGA,EAAImsC,EAAkBjuC,OAAQ8B,IAC5CssC,GAAWH,EAAkBnsC,GAAI,mBAAoB2iB,EAAOwQ,OAK7D0Y,EACH,IAAKx+B,KAAO0+B,EACLE,EAAQ5+B,IAEXi/B,GAAWP,EAAQ1+B,GAAM,SAAU8lB,EAAUA,EAAU2Y,GAM/D,IAAIW,GAAiB3rC,OAAO2Y,OAAO,MAEnC,SAASuyB,GACP3lB,EACAf,GAEA,IAKItlB,EAAG4rC,EALH/gC,EAAM/J,OAAO2Y,OAAO,MACxB,IAAK4M,EAEH,OAAOxb,EAGT,IAAK7K,EAAI,EAAGA,EAAIqmB,EAAKnoB,OAAQ8B,IAC3B4rC,EAAMvlB,EAAKrmB,GACN4rC,EAAIc,YAEPd,EAAIc,UAAYD,IAElB5hC,EAAI8hC,GAAcf,IAAQA,EAC1BA,EAAIzlC,IAAM2gB,GAAaxB,EAAG1N,SAAU,aAAcg0B,EAAI9pC,MAAM,GAG9D,OAAO+I,EAGT,SAAS8hC,GAAef,GACtB,OAAOA,EAAIgB,SAAahB,EAAQ,KAAI,IAAO9qC,OAAOmb,KAAK2vB,EAAIc,WAAa,IAAIxsC,KAAK,KAGnF,SAASosC,GAAYV,EAAK50B,EAAM2L,EAAOwQ,EAAU2Y,GAC/C,IAAI9tC,EAAK4tC,EAAIzlC,KAAOylC,EAAIzlC,IAAI6Q,GAC5B,GAAIhZ,EACF,IACEA,EAAG2kB,EAAMvB,IAAKwqB,EAAKjpB,EAAOwQ,EAAU2Y,GACpC,MAAO1gC,IACP4c,GAAY5c,GAAGuX,EAAMxL,QAAU,aAAgBy0B,EAAQ,KAAI,IAAM50B,EAAO,UAK9E,IAAI61B,GAAc,CAChBvW,GACAhQ,IAKF,SAASwmB,GAAa3Z,EAAUxQ,GAC9B,IAAIxD,EAAOwD,EAAMtB,iBACjB,KAAI9I,EAAM4G,KAA4C,IAAnCA,EAAKO,KAAKjO,QAAQs7B,iBAGjC10B,EAAQ8a,EAAS7uB,KAAKiJ,SAAU8K,EAAQsK,EAAMre,KAAKiJ,QAAvD,CAGA,IAAIF,EAAK8a,EAAK6C,EACV5J,EAAMuB,EAAMvB,IACZ4rB,EAAW7Z,EAAS7uB,KAAKiJ,OAAS,GAClCA,EAAQoV,EAAMre,KAAKiJ,OAAS,GAMhC,IAAKF,KAJDkL,EAAMhL,EAAM4V,UACd5V,EAAQoV,EAAMre,KAAKiJ,MAAQ2N,EAAO,GAAI3N,IAG5BA,EACV4a,EAAM5a,EAAMF,GACZ2d,EAAMgiB,EAAS3/B,GACX2d,IAAQ7C,GACV8kB,GAAQ7rB,EAAK/T,EAAK8a,GAStB,IAAK9a,KAHAsR,IAAQE,KAAWtR,EAAMvF,QAAUglC,EAAShlC,OAC/CilC,GAAQ7rB,EAAK,QAAS7T,EAAMvF,OAElBglC,EACN30B,EAAQ9K,EAAMF,MACZy2B,GAAQz2B,GACV+T,EAAI8rB,kBAAkBrJ,GAASE,GAAa12B,IAClCm2B,GAAiBn2B,IAC3B+T,EAAIiqB,gBAAgBh+B,KAM5B,SAAS4/B,GAAS9S,EAAI9sB,EAAKrF,GACrBmyB,EAAGoL,QAAQ1vB,QAAQ,MAAQ,EAC7Bs3B,GAAYhT,EAAI9sB,EAAKrF,GACZ47B,GAAcv2B,GAGnBs2B,GAAiB37B,GACnBmyB,EAAGkR,gBAAgBh+B,IAInBrF,EAAgB,oBAARqF,GAA4C,UAAf8sB,EAAGoL,QACpC,OACAl4B,EACJ8sB,EAAGsL,aAAap4B,EAAKrF,IAEdw7B,GAAiBn2B,GAC1B8sB,EAAGsL,aAAap4B,EAAKq2B,GAAuBr2B,EAAKrF,IACxC87B,GAAQz2B,GACbs2B,GAAiB37B,GACnBmyB,EAAG+S,kBAAkBrJ,GAASE,GAAa12B,IAE3C8sB,EAAGiT,eAAevJ,GAASx2B,EAAKrF,GAGlCmlC,GAAYhT,EAAI9sB,EAAKrF,GAIzB,SAASmlC,GAAahT,EAAI9sB,EAAKrF,GAC7B,GAAI27B,GAAiB37B,GACnBmyB,EAAGkR,gBAAgBh+B,OACd,CAKL,GACEsR,KAASC,IACM,aAAfub,EAAGoL,SACK,gBAARl4B,GAAmC,KAAVrF,IAAiBmyB,EAAGkT,OAC7C,CACA,IAAIC,EAAU,SAAUliC,GACtBA,EAAEmiC,2BACFpT,EAAGqT,oBAAoB,QAASF,IAElCnT,EAAG/a,iBAAiB,QAASkuB,GAE7BnT,EAAGkT,QAAS,EAEdlT,EAAGsL,aAAap4B,EAAKrF,IAIzB,IAAIuF,GAAQ,CACVkM,OAAQqzB,GACRhsB,OAAQgsB,IAKV,SAASW,GAAata,EAAUxQ,GAC9B,IAAIwX,EAAKxX,EAAMvB,IACX9c,EAAOqe,EAAMre,KACbopC,EAAUva,EAAS7uB,KACvB,KACE+T,EAAQ/T,EAAK4D,cACbmQ,EAAQ/T,EAAK6D,SACXkQ,EAAQq1B,IACNr1B,EAAQq1B,EAAQxlC,cAChBmQ,EAAQq1B,EAAQvlC,SALtB,CAYA,IAAIwlC,EAAM3J,GAAiBrhB,GAGvBirB,EAAkBzT,EAAG0T,mBACrBt1B,EAAMq1B,KACRD,EAAMrtC,GAAOqtC,EAAKrJ,GAAesJ,KAI/BD,IAAQxT,EAAG2T,aACb3T,EAAGsL,aAAa,QAASkI,GACzBxT,EAAG2T,WAAaH,IAIpB,IAyCII,GAzCAC,GAAQ,CACVv0B,OAAQg0B,GACR3sB,OAAQ2sB,IAaNQ,GAAc,MACdC,GAAuB,MAQ3B,SAASC,GAAiB1gC,GAExB,GAAI8K,EAAM9K,EAAGwgC,KAAe,CAE1B,IAAIhjB,EAAQtM,GAAO,SAAW,QAC9BlR,EAAGwd,GAAS,GAAG3qB,OAAOmN,EAAGwgC,IAAcxgC,EAAGwd,IAAU,WAC7Cxd,EAAGwgC,IAKR11B,EAAM9K,EAAGygC,OACXzgC,EAAG2gC,OAAS,GAAG9tC,OAAOmN,EAAGygC,IAAuBzgC,EAAG2gC,QAAU,WACtD3gC,EAAGygC,KAMd,SAASG,GAAqBpjB,EAAOzC,EAASjjB,GAC5C,IAAI8yB,EAAU0V,GACd,OAAO,SAASzV,IACd,IAAIztB,EAAM2d,EAAQhqB,MAAM,KAAMC,WAClB,OAARoM,GACFyjC,GAASrjB,EAAOqN,EAAa/yB,EAAS8yB,IAQ5C,IAAIkW,GAAkB1lB,MAAsB9J,IAAQ9S,OAAO8S,GAAK,KAAO,IAEvE,SAASyvB,GACP1sC,EACA0mB,EACAjjB,EACA+kB,GAQA,GAAIikB,GAAiB,CACnB,IAAIE,EAAoBhT,GACpBzY,EAAWwF,EACfA,EAAUxF,EAAS0rB,SAAW,SAAUtjC,GACtC,GAIEA,EAAEpM,SAAWoM,EAAEujC,eAEfvjC,EAAEywB,WAAa4S,GAIfrjC,EAAEywB,WAAa,GAIfzwB,EAAEpM,OAAO4vC,gBAAkBplB,SAE3B,OAAOxG,EAASxkB,MAAMa,KAAMZ,YAIlCsvC,GAAS3uB,iBACPtd,EACA0mB,EACAtJ,GACI,CAAE3Z,QAASA,EAAS+kB,QAASA,GAC7B/kB,GAIR,SAAS+oC,GACPxsC,EACA0mB,EACAjjB,EACA8yB,IAECA,GAAW0V,IAAUP,oBACpB1rC,EACA0mB,EAAQkmB,UAAYlmB,EACpBjjB,GAIJ,SAASspC,GAAoB1b,EAAUxQ,GACrC,IAAItK,EAAQ8a,EAAS7uB,KAAKmJ,MAAO4K,EAAQsK,EAAMre,KAAKmJ,IAApD,CAGA,IAAIA,EAAKkV,EAAMre,KAAKmJ,IAAM,GACtBod,EAAQsI,EAAS7uB,KAAKmJ,IAAM,GAChCsgC,GAAWprB,EAAMvB,IACjB+sB,GAAgB1gC,GAChBmd,GAAgBnd,EAAIod,EAAO2jB,GAAOF,GAAUD,GAAqB1rB,EAAMxL,SACvE42B,QAAW5vC,GAGb,IAOI2wC,GAPAC,GAAS,CACXt1B,OAAQo1B,GACR/tB,OAAQ+tB,IAOV,SAASG,GAAgB7b,EAAUxQ,GACjC,IAAItK,EAAQ8a,EAAS7uB,KAAK4qB,YAAa7W,EAAQsK,EAAMre,KAAK4qB,UAA1D,CAGA,IAAI7hB,EAAK8a,EACL/G,EAAMuB,EAAMvB,IACZ6tB,EAAW9b,EAAS7uB,KAAK4qB,UAAY,GACrCjpB,EAAQ0c,EAAMre,KAAK4qB,UAAY,GAMnC,IAAK7hB,KAJDkL,EAAMtS,EAAMkd,UACdld,EAAQ0c,EAAMre,KAAK4qB,SAAWhU,EAAO,GAAIjV,IAG/BgpC,EACJ5hC,KAAOpH,IACXmb,EAAI/T,GAAO,IAIf,IAAKA,KAAOpH,EAAO,CAKjB,GAJAkiB,EAAMliB,EAAMoH,GAIA,gBAARA,GAAiC,cAARA,EAAqB,CAEhD,GADIsV,EAAM9a,WAAY8a,EAAM9a,SAAS3J,OAAS,GAC1CiqB,IAAQ8mB,EAAS5hC,GAAQ,SAGC,IAA1B+T,EAAI8tB,WAAWhxC,QACjBkjB,EAAI4kB,YAAY5kB,EAAI8tB,WAAW,IAInC,GAAY,UAAR7hC,GAAmC,aAAhB+T,EAAImkB,QAAwB,CAGjDnkB,EAAI+tB,OAAShnB,EAEb,IAAIinB,EAAS/2B,EAAQ8P,GAAO,GAAKrqB,OAAOqqB,GACpCknB,GAAkBjuB,EAAKguB,KACzBhuB,EAAIpZ,MAAQonC,QAET,GAAY,cAAR/hC,GAAuBy3B,GAAM1jB,EAAImkB,UAAYltB,EAAQ+I,EAAIypB,WAAY,CAE9EiE,GAAeA,IAAgBtlB,SAAS9jB,cAAc,OACtDopC,GAAajE,UAAY,QAAU1iB,EAAM,SACzC,IAAIwc,EAAMmK,GAAa/D,WACvB,MAAO3pB,EAAI2pB,WACT3pB,EAAI4kB,YAAY5kB,EAAI2pB,YAEtB,MAAOpG,EAAIoG,WACT3pB,EAAI6kB,YAAYtB,EAAIoG,iBAEjB,GAKL5iB,IAAQ8mB,EAAS5hC,GAIjB,IACE+T,EAAI/T,GAAO8a,EACX,MAAO/c,QAQf,SAASikC,GAAmBjuB,EAAKkuB,GAC/B,OAASluB,EAAImuB,YACK,WAAhBnuB,EAAImkB,SACJiK,GAAqBpuB,EAAKkuB,IAC1BG,GAAqBruB,EAAKkuB,IAI9B,SAASE,GAAsBpuB,EAAKkuB,GAGlC,IAAII,GAAa,EAGjB,IAAMA,EAAalmB,SAASmmB,gBAAkBvuB,EAAO,MAAOhW,KAC5D,OAAOskC,GAActuB,EAAIpZ,QAAUsnC,EAGrC,SAASG,GAAsBruB,EAAKwD,GAClC,IAAI5c,EAAQoZ,EAAIpZ,MACZ0kC,EAAYtrB,EAAIwuB,YACpB,GAAIr3B,EAAMm0B,GAAY,CACpB,GAAIA,EAAUmD,OACZ,OAAOz2B,EAASpR,KAAWoR,EAASwL,GAEtC,GAAI8nB,EAAUoD,KACZ,OAAO9nC,EAAM8nC,SAAWlrB,EAAOkrB,OAGnC,OAAO9nC,IAAU4c,EAGnB,IAAIsK,GAAW,CACbzV,OAAQu1B,GACRluB,OAAQkuB,IAKNe,GAAiB/1B,GAAO,SAAUg2B,GACpC,IAAInlC,EAAM,GACNolC,EAAgB,gBAChBC,EAAoB,QAOxB,OANAF,EAAQvmC,MAAMwmC,GAAensC,SAAQ,SAAU8V,GAC7C,GAAIA,EAAM,CACR,IAAI0jB,EAAM1jB,EAAKnQ,MAAMymC,GACrB5S,EAAIp/B,OAAS,IAAM2M,EAAIyyB,EAAI,GAAGwS,QAAUxS,EAAI,GAAGwS,YAG5CjlC,KAIT,SAASslC,GAAoB7rC,GAC3B,IAAIuJ,EAAQuiC,GAAsB9rC,EAAKuJ,OAGvC,OAAOvJ,EAAK+rC,YACRn1B,EAAO5W,EAAK+rC,YAAaxiC,GACzBA,EAIN,SAASuiC,GAAuBE,GAC9B,OAAI/uC,MAAM4X,QAAQm3B,GACT1xC,EAAS0xC,GAEU,kBAAjBA,EACFP,GAAeO,GAEjBA,EAOT,SAASC,GAAU5tB,EAAO6tB,GACxB,IACIC,EADA5lC,EAAM,GAGV,GAAI2lC,EAAY,CACd,IAAItM,EAAYvhB,EAChB,MAAOuhB,EAAUviB,kBACfuiB,EAAYA,EAAUviB,kBAAkBiU,OAEtCsO,GAAaA,EAAU5/B,OACtBmsC,EAAYN,GAAmBjM,EAAU5/B,QAE1C4W,EAAOrQ,EAAK4lC,IAKbA,EAAYN,GAAmBxtB,EAAMre,QACxC4W,EAAOrQ,EAAK4lC,GAGd,IAAIxM,EAAathB,EACjB,MAAQshB,EAAaA,EAAW3sB,OAC1B2sB,EAAW3/B,OAASmsC,EAAYN,GAAmBlM,EAAW3/B,QAChE4W,EAAOrQ,EAAK4lC,GAGhB,OAAO5lC,EAKT,IAyBI6lC,GAzBAC,GAAW,MACXC,GAAc,iBACdC,GAAU,SAAU1W,EAAIr4B,EAAMsF,GAEhC,GAAIupC,GAAShzC,KAAKmE,GAChBq4B,EAAGtsB,MAAMijC,YAAYhvC,EAAMsF,QACtB,GAAIwpC,GAAYjzC,KAAKyJ,GAC1B+yB,EAAGtsB,MAAMijC,YAAYt2B,EAAU1Y,GAAOsF,EAAI3C,QAAQmsC,GAAa,IAAK,iBAC/D,CACL,IAAIG,EAAiBC,GAAUlvC,GAC/B,GAAIP,MAAM4X,QAAQ/R,GAIhB,IAAK,IAAIpH,EAAI,EAAGqB,EAAM+F,EAAIlJ,OAAQ8B,EAAIqB,EAAKrB,IACzCm6B,EAAGtsB,MAAMkjC,GAAkB3pC,EAAIpH,QAGjCm6B,EAAGtsB,MAAMkjC,GAAkB3pC,IAK7B6pC,GAAc,CAAC,SAAU,MAAO,MAGhCD,GAAYh3B,GAAO,SAAU1S,GAG/B,GAFAopC,GAAaA,IAAclnB,SAAS9jB,cAAc,OAAOmI,MACzDvG,EAAO6S,EAAS7S,GACH,WAATA,GAAsBA,KAAQopC,GAChC,OAAOppC,EAGT,IADA,IAAI4pC,EAAU5pC,EAAK9B,OAAO,GAAG6U,cAAgB/S,EAAK7H,MAAM,GAC/CO,EAAI,EAAGA,EAAIixC,GAAY/yC,OAAQ8B,IAAK,CAC3C,IAAI8B,EAAOmvC,GAAYjxC,GAAKkxC,EAC5B,GAAIpvC,KAAQ4uC,GACV,OAAO5uC,MAKb,SAASqvC,GAAahe,EAAUxQ,GAC9B,IAAIre,EAAOqe,EAAMre,KACbopC,EAAUva,EAAS7uB,KAEvB,KAAI+T,EAAQ/T,EAAK+rC,cAAgBh4B,EAAQ/T,EAAKuJ,QAC5CwK,EAAQq1B,EAAQ2C,cAAgBh4B,EAAQq1B,EAAQ7/B,QADlD,CAMA,IAAIsa,EAAKrmB,EACLq4B,EAAKxX,EAAMvB,IACXgwB,EAAiB1D,EAAQ2C,YACzBgB,EAAkB3D,EAAQ4D,iBAAmB5D,EAAQ7/B,OAAS,GAG9D0jC,EAAWH,GAAkBC,EAE7BxjC,EAAQuiC,GAAsBztB,EAAMre,KAAKuJ,QAAU,GAKvD8U,EAAMre,KAAKgtC,gBAAkB/4B,EAAM1K,EAAMsV,QACrCjI,EAAO,GAAIrN,GACXA,EAEJ,IAAI2jC,EAAWjB,GAAS5tB,GAAO,GAE/B,IAAK7gB,KAAQyvC,EACPl5B,EAAQm5B,EAAS1vC,KACnB+uC,GAAQ1W,EAAIr4B,EAAM,IAGtB,IAAKA,KAAQ0vC,EACXrpB,EAAMqpB,EAAS1vC,GACXqmB,IAAQopB,EAASzvC,IAEnB+uC,GAAQ1W,EAAIr4B,EAAa,MAAPqmB,EAAc,GAAKA,IAK3C,IAAIta,GAAQ,CACV4L,OAAQ03B,GACRrwB,OAAQqwB,IAKNM,GAAe,MAMnB,SAASC,GAAUvX,EAAIwT,GAErB,GAAKA,IAASA,EAAMA,EAAImC,QAKxB,GAAI3V,EAAGpyB,UACD4lC,EAAI93B,QAAQ,MAAQ,EACtB83B,EAAIlkC,MAAMgoC,IAAc3tC,SAAQ,SAAUvF,GAAK,OAAO47B,EAAGpyB,UAAU0P,IAAIlZ,MAEvE47B,EAAGpyB,UAAU0P,IAAIk2B,OAEd,CACL,IAAIxlB,EAAM,KAAOgS,EAAGwX,aAAa,UAAY,IAAM,IAC/CxpB,EAAItS,QAAQ,IAAM83B,EAAM,KAAO,GACjCxT,EAAGsL,aAAa,SAAUtd,EAAMwlB,GAAKmC,SAS3C,SAAS8B,GAAazX,EAAIwT,GAExB,GAAKA,IAASA,EAAMA,EAAImC,QAKxB,GAAI3V,EAAGpyB,UACD4lC,EAAI93B,QAAQ,MAAQ,EACtB83B,EAAIlkC,MAAMgoC,IAAc3tC,SAAQ,SAAUvF,GAAK,OAAO47B,EAAGpyB,UAAU4R,OAAOpb,MAE1E47B,EAAGpyB,UAAU4R,OAAOg0B,GAEjBxT,EAAGpyB,UAAU7J,QAChBi8B,EAAGkR,gBAAgB,aAEhB,CACL,IAAIljB,EAAM,KAAOgS,EAAGwX,aAAa,UAAY,IAAM,IAC/CE,EAAM,IAAMlE,EAAM,IACtB,MAAOxlB,EAAItS,QAAQg8B,IAAQ,EACzB1pB,EAAMA,EAAI1jB,QAAQotC,EAAK,KAEzB1pB,EAAMA,EAAI2nB,OACN3nB,EACFgS,EAAGsL,aAAa,QAAStd,GAEzBgS,EAAGkR,gBAAgB,UAOzB,SAASyG,GAAmBvrB,GAC1B,GAAKA,EAAL,CAIA,GAAsB,kBAAXA,EAAqB,CAC9B,IAAI1b,EAAM,GAKV,OAJmB,IAAf0b,EAAOwrB,KACT72B,EAAOrQ,EAAKmnC,GAAkBzrB,EAAOzkB,MAAQ,MAE/CoZ,EAAOrQ,EAAK0b,GACL1b,EACF,MAAsB,kBAAX0b,EACTyrB,GAAkBzrB,QADpB,GAKT,IAAIyrB,GAAoBh4B,GAAO,SAAUlY,GACvC,MAAO,CACLmwC,WAAanwC,EAAO,SACpBowC,aAAepwC,EAAO,YACtBqwC,iBAAmBrwC,EAAO,gBAC1BswC,WAAatwC,EAAO,SACpBuwC,aAAevwC,EAAO,YACtBwwC,iBAAmBxwC,EAAO,oBAI1BywC,GAAgBn0B,IAAcQ,GAC9B4zB,GAAa,aACbC,GAAY,YAGZC,GAAiB,aACjBC,GAAqB,gBACrBC,GAAgB,YAChBC,GAAoB,eACpBN,UAE6Bp0C,IAA3B0C,OAAOiyC,sBACwB30C,IAAjC0C,OAAOkyC,wBAEPL,GAAiB,mBACjBC,GAAqB,4BAEOx0C,IAA1B0C,OAAOmyC,qBACuB70C,IAAhC0C,OAAOoyC,uBAEPL,GAAgB,kBAChBC,GAAoB,uBAKxB,IAAIK,GAAM90B,EACNvd,OAAOsyC,sBACLtyC,OAAOsyC,sBAAsBhzC,KAAKU,QAClCqoB,WACyB,SAAUlrB,GAAM,OAAOA,KAEtD,SAASo1C,GAAWp1C,GAClBk1C,IAAI,WACFA,GAAIl1C,MAIR,SAASq1C,GAAoBlZ,EAAIwT,GAC/B,IAAI2F,EAAoBnZ,EAAG0T,qBAAuB1T,EAAG0T,mBAAqB,IACtEyF,EAAkBz9B,QAAQ83B,GAAO,IACnC2F,EAAkBnvC,KAAKwpC,GACvB+D,GAASvX,EAAIwT,IAIjB,SAAS4F,GAAuBpZ,EAAIwT,GAC9BxT,EAAG0T,oBACLl0B,EAAOwgB,EAAG0T,mBAAoBF,GAEhCiE,GAAYzX,EAAIwT,GAGlB,SAAS6F,GACPrZ,EACAsZ,EACA7pB,GAEA,IAAI0M,EAAMod,GAAkBvZ,EAAIsZ,GAC5BntC,EAAOgwB,EAAIhwB,KACXsO,EAAU0hB,EAAI1hB,QACd++B,EAAYrd,EAAIqd,UACpB,IAAKrtC,EAAQ,OAAOsjB,IACpB,IAAIqB,EAAQ3kB,IAASksC,GAAaG,GAAqBE,GACnDe,EAAQ,EACRvJ,EAAM,WACRlQ,EAAGqT,oBAAoBviB,EAAO4oB,GAC9BjqB,KAEEiqB,EAAQ,SAAUzoC,GAChBA,EAAEpM,SAAWm7B,KACTyZ,GAASD,GACbtJ,KAINnhB,YAAW,WACL0qB,EAAQD,GACVtJ,MAEDz1B,EAAU,GACbulB,EAAG/a,iBAAiB6L,EAAO4oB,GAG7B,IAAIC,GAAc,yBAElB,SAASJ,GAAmBvZ,EAAIsZ,GAC9B,IASIntC,EATAkP,EAAS3U,OAAOkzC,iBAAiB5Z,GAEjC6Z,GAAoBx+B,EAAOk9B,GAAiB,UAAY,IAAIjpC,MAAM,MAClEwqC,GAAuBz+B,EAAOk9B,GAAiB,aAAe,IAAIjpC,MAAM,MACxEyqC,EAAoBC,GAAWH,EAAkBC,GACjDG,GAAmB5+B,EAAOo9B,GAAgB,UAAY,IAAInpC,MAAM,MAChE4qC,GAAsB7+B,EAAOo9B,GAAgB,aAAe,IAAInpC,MAAM,MACtE6qC,EAAmBH,GAAWC,EAAiBC,GAG/Cz/B,EAAU,EACV++B,EAAY,EAEZF,IAAiBjB,GACf0B,EAAoB,IACtB5tC,EAAOksC,GACP59B,EAAUs/B,EACVP,EAAYM,EAAoB/1C,QAEzBu1C,IAAiBhB,GACtB6B,EAAmB,IACrBhuC,EAAOmsC,GACP79B,EAAU0/B,EACVX,EAAYU,EAAmBn2C,SAGjC0W,EAAUpQ,KAAK2N,IAAI+hC,EAAmBI,GACtChuC,EAAOsO,EAAU,EACbs/B,EAAoBI,EAClB9B,GACAC,GACF,KACJkB,EAAYrtC,EACRA,IAASksC,GACPyB,EAAoB/1C,OACpBm2C,EAAmBn2C,OACrB,GAEN,IAAIq2C,EACFjuC,IAASksC,IACTsB,GAAYn2C,KAAK6X,EAAOk9B,GAAiB,aAC3C,MAAO,CACLpsC,KAAMA,EACNsO,QAASA,EACT++B,UAAWA,EACXY,aAAcA,GAIlB,SAASJ,GAAYK,EAAQC,GAE3B,MAAOD,EAAOt2C,OAASu2C,EAAUv2C,OAC/Bs2C,EAASA,EAAOl0C,OAAOk0C,GAGzB,OAAOhwC,KAAK2N,IAAI3T,MAAM,KAAMi2C,EAAUj7B,KAAI,SAAU7K,EAAG3O,GACrD,OAAO00C,GAAK/lC,GAAK+lC,GAAKF,EAAOx0C,QAQjC,SAAS00C,GAAMC,GACb,OAAkD,IAA3C1oC,OAAO0oC,EAAEl1C,MAAM,GAAI,GAAGgF,QAAQ,IAAK,MAK5C,SAASmwC,GAAOjyB,EAAOkyB,GACrB,IAAI1a,EAAKxX,EAAMvB,IAGX7I,EAAM4hB,EAAGoR,YACXpR,EAAGoR,SAASuJ,WAAY,EACxB3a,EAAGoR,YAGL,IAAIjnC,EAAOwtC,GAAkBnvB,EAAMre,KAAKmkC,YACxC,IAAIpwB,EAAQ/T,KAKRiU,EAAM4hB,EAAG4a,WAA6B,IAAhB5a,EAAGgR,SAA7B,CAIA,IAAI4G,EAAMztC,EAAKytC,IACXzrC,EAAOhC,EAAKgC,KACZ2rC,EAAa3tC,EAAK2tC,WAClBC,EAAe5tC,EAAK4tC,aACpBC,EAAmB7tC,EAAK6tC,iBACxB6C,EAAc1wC,EAAK0wC,YACnBC,EAAgB3wC,EAAK2wC,cACrBC,EAAoB5wC,EAAK4wC,kBACzBC,EAAc7wC,EAAK6wC,YACnBP,EAAQtwC,EAAKswC,MACbQ,EAAa9wC,EAAK8wC,WAClBC,EAAiB/wC,EAAK+wC,eACtBC,EAAehxC,EAAKgxC,aACpBC,EAASjxC,EAAKixC,OACdC,EAAclxC,EAAKkxC,YACnBC,EAAkBnxC,EAAKmxC,gBACvBC,EAAWpxC,EAAKoxC,SAMhBv+B,EAAU8b,GACV0iB,EAAiB1iB,GAAe7b,OACpC,MAAOu+B,GAAkBA,EAAer+B,OACtCH,EAAUw+B,EAAex+B,QACzBw+B,EAAiBA,EAAer+B,OAGlC,IAAIs+B,GAAYz+B,EAAQmc,aAAe3Q,EAAMb,aAE7C,IAAI8zB,GAAaL,GAAqB,KAAXA,EAA3B,CAIA,IAAIM,EAAaD,GAAYZ,EACzBA,EACA/C,EACA6D,EAAcF,GAAYV,EAC1BA,EACA/C,EACA4D,EAAUH,GAAYX,EACtBA,EACA/C,EAEA8D,EAAkBJ,GACjBN,GACDH,EACAc,EAAYL,GACO,oBAAXL,EAAwBA,EAChCX,EACAsB,EAAiBN,GAChBJ,GACDJ,EACAe,EAAqBP,GACpBH,GACDJ,EAEAe,EAAwBh9B,EAC1B5Z,EAASk2C,GACLA,EAASd,MACTc,GAGF,EAIJ,IAAIW,GAAqB,IAARtE,IAAkBnzB,GAC/B03B,EAAmBC,GAAuBN,GAE1CrsB,EAAKuQ,EAAG4a,SAAW34B,GAAK,WACtBi6B,IACF9C,GAAsBpZ,EAAI4b,GAC1BxC,GAAsBpZ,EAAI2b,IAExBlsB,EAAGkrB,WACDuB,GACF9C,GAAsBpZ,EAAI0b,GAE5BM,GAAsBA,EAAmBhc,IAEzC+b,GAAkBA,EAAe/b,GAEnCA,EAAG4a,SAAW,QAGXpyB,EAAMre,KAAKkyC,MAEdrrB,GAAexI,EAAO,UAAU,WAC9B,IAAIrL,EAAS6iB,EAAG8J,WACZwS,EAAcn/B,GAAUA,EAAOo/B,UAAYp/B,EAAOo/B,SAAS/zB,EAAMtV,KACjEopC,GACFA,EAAYhvC,MAAQkb,EAAMlb,KAC1BgvC,EAAYr1B,IAAImqB,UAEhBkL,EAAYr1B,IAAImqB,WAElB0K,GAAaA,EAAU9b,EAAIvQ,MAK/BosB,GAAmBA,EAAgB7b,GAC/Bkc,IACFhD,GAAmBlZ,EAAI0b,GACvBxC,GAAmBlZ,EAAI2b,GACvB1C,IAAU,WACRG,GAAsBpZ,EAAI0b,GACrBjsB,EAAGkrB,YACNzB,GAAmBlZ,EAAI4b,GAClBO,IACCK,GAAgBP,GAClBltB,WAAWU,EAAIwsB,GAEf5C,GAAmBrZ,EAAI7zB,EAAMsjB,SAOnCjH,EAAMre,KAAKkyC,OACb3B,GAAiBA,IACjBoB,GAAaA,EAAU9b,EAAIvQ,IAGxBysB,GAAeC,GAClB1sB,MAIJ,SAASgtB,GAAOj0B,EAAOumB,GACrB,IAAI/O,EAAKxX,EAAMvB,IAGX7I,EAAM4hB,EAAG4a,YACX5a,EAAG4a,SAASD,WAAY,EACxB3a,EAAG4a,YAGL,IAAIzwC,EAAOwtC,GAAkBnvB,EAAMre,KAAKmkC,YACxC,GAAIpwB,EAAQ/T,IAAyB,IAAhB61B,EAAGgR,SACtB,OAAOjC,IAIT,IAAI3wB,EAAM4hB,EAAGoR,UAAb,CAIA,IAAIwG,EAAMztC,EAAKytC,IACXzrC,EAAOhC,EAAKgC,KACZ8rC,EAAa9tC,EAAK8tC,WAClBC,EAAe/tC,EAAK+tC,aACpBC,EAAmBhuC,EAAKguC,iBACxBuE,EAAcvyC,EAAKuyC,YACnBD,EAAQtyC,EAAKsyC,MACbE,EAAaxyC,EAAKwyC,WAClBC,EAAiBzyC,EAAKyyC,eACtBC,EAAa1yC,EAAK0yC,WAClBtB,EAAWpxC,EAAKoxC,SAEhBW,GAAqB,IAARtE,IAAkBnzB,GAC/B03B,EAAmBC,GAAuBK,GAE1CK,EAAwB79B,EAC1B5Z,EAASk2C,GACLA,EAASkB,MACTlB,GAGF,EAIJ,IAAI9rB,EAAKuQ,EAAGoR,SAAWnvB,GAAK,WACtB+d,EAAG8J,YAAc9J,EAAG8J,WAAWyS,WACjCvc,EAAG8J,WAAWyS,SAAS/zB,EAAMtV,KAAO,MAElCgpC,IACF9C,GAAsBpZ,EAAIkY,GAC1BkB,GAAsBpZ,EAAImY,IAExB1oB,EAAGkrB,WACDuB,GACF9C,GAAsBpZ,EAAIiY,GAE5B2E,GAAkBA,EAAe5c,KAEjC+O,IACA4N,GAAcA,EAAW3c,IAE3BA,EAAGoR,SAAW,QAGZyL,EACFA,EAAWE,GAEXA,IAGF,SAASA,IAEHttB,EAAGkrB,aAIFnyB,EAAMre,KAAKkyC,MAAQrc,EAAG8J,cACxB9J,EAAG8J,WAAWyS,WAAavc,EAAG8J,WAAWyS,SAAW,KAAM/zB,EAAS,KAAKA,GAE3Ek0B,GAAeA,EAAY1c,GACvBkc,IACFhD,GAAmBlZ,EAAIiY,GACvBiB,GAAmBlZ,EAAImY,GACvBc,IAAU,WACRG,GAAsBpZ,EAAIiY,GACrBxoB,EAAGkrB,YACNzB,GAAmBlZ,EAAIkY,GAClBiE,IACCK,GAAgBM,GAClB/tB,WAAWU,EAAIqtB,GAEfzD,GAAmBrZ,EAAI7zB,EAAMsjB,SAMvCgtB,GAASA,EAAMzc,EAAIvQ,GACdysB,GAAeC,GAClB1sB,MAsBN,SAAS+sB,GAAiBvvC,GACxB,MAAsB,kBAARA,IAAqBiS,MAAMjS,GAS3C,SAASmvC,GAAwBv4C,GAC/B,GAAIqa,EAAQra,GACV,OAAO,EAET,IAAIm5C,EAAan5C,EAAGysB,IACpB,OAAIlS,EAAM4+B,GAEDZ,GACLh1C,MAAM4X,QAAQg+B,GACVA,EAAW,GACXA,IAGEn5C,EAAG6c,SAAW7c,EAAGE,QAAU,EAIvC,SAASk5C,GAAQh9B,EAAGuI,IACM,IAApBA,EAAMre,KAAKkyC,MACb5B,GAAMjyB,GAIV,IAAI8lB,GAAarqB,EAAY,CAC3B3E,OAAQ29B,GACR1O,SAAU0O,GACVz9B,OAAQ,SAAoBgJ,EAAOumB,IAET,IAApBvmB,EAAMre,KAAKkyC,KACbI,GAAMj0B,EAAOumB,GAEbA,MAGF,GAEAmO,GAAkB,CACpB9pC,GACAygC,GACAe,GACA7f,GACArhB,GACA46B,IAOEpB,GAAUgQ,GAAgB/2C,OAAOusC,IAEjCyK,GAAQnQ,GAAoB,CAAEb,QAASA,GAASe,QAASA,KAQzDzoB,IAEF4K,SAASpK,iBAAiB,mBAAmB,WAC3C,IAAI+a,EAAK3Q,SAASmmB,cACdxV,GAAMA,EAAGod,QACXC,GAAQrd,EAAI,YAKlB,IAAIsd,GAAY,CACdx0B,SAAU,SAAmBkX,EAAIud,EAAS/0B,EAAOwQ,GAC7B,WAAdxQ,EAAMlb,KAEJ0rB,EAAS/R,MAAQ+R,EAAS/R,IAAIu2B,UAChCxsB,GAAexI,EAAO,aAAa,WACjC80B,GAAUlL,iBAAiBpS,EAAIud,EAAS/0B,MAG1Ci1B,GAAYzd,EAAIud,EAAS/0B,EAAMxL,SAEjCgjB,EAAGwd,UAAY,GAAGn+B,IAAIpb,KAAK+7B,EAAG1oB,QAASomC,MAChB,aAAdl1B,EAAMlb,KAAsBy9B,GAAgB/K,EAAG7zB,SACxD6zB,EAAGyV,YAAc8H,EAAQhL,UACpBgL,EAAQhL,UAAU7P,OACrB1C,EAAG/a,iBAAiB,mBAAoB04B,IACxC3d,EAAG/a,iBAAiB,iBAAkB24B,IAKtC5d,EAAG/a,iBAAiB,SAAU24B,IAE1Bn5B,KACFub,EAAGod,QAAS,MAMpBhL,iBAAkB,SAA2BpS,EAAIud,EAAS/0B,GACxD,GAAkB,WAAdA,EAAMlb,IAAkB,CAC1BmwC,GAAYzd,EAAIud,EAAS/0B,EAAMxL,SAK/B,IAAI6gC,EAAc7d,EAAGwd,UACjBM,EAAa9d,EAAGwd,UAAY,GAAGn+B,IAAIpb,KAAK+7B,EAAG1oB,QAASomC,IACxD,GAAII,EAAW1sC,MAAK,SAAU9J,EAAGzB,GAAK,OAAQwb,EAAW/Z,EAAGu2C,EAAYh4C,OAAS,CAG/E,IAAIk4C,EAAY/d,EAAGqL,SACfkS,EAAQ1vC,MAAMuD,MAAK,SAAU+M,GAAK,OAAO6/B,GAAoB7/B,EAAG2/B,MAChEP,EAAQ1vC,QAAU0vC,EAAQna,UAAY4a,GAAoBT,EAAQ1vC,MAAOiwC,GACzEC,GACFV,GAAQrd,EAAI,cAOtB,SAASyd,GAAazd,EAAIud,EAASpyB,GACjC8yB,GAAoBje,EAAIud,EAASpyB,IAE7B3G,IAAQE,KACVqK,YAAW,WACTkvB,GAAoBje,EAAIud,EAASpyB,KAChC,GAIP,SAAS8yB,GAAqBje,EAAIud,EAASpyB,GACzC,IAAItd,EAAQ0vC,EAAQ1vC,MAChBqwC,EAAale,EAAGqL,SACpB,IAAI6S,GAAe92C,MAAM4X,QAAQnR,GAAjC,CASA,IADA,IAAIo9B,EAAUkT,EACLt4C,EAAI,EAAG4a,EAAIuf,EAAG1oB,QAAQvT,OAAQ8B,EAAI4a,EAAG5a,IAE5C,GADAs4C,EAASne,EAAG1oB,QAAQzR,GAChBq4C,EACFjT,EAAWjpB,EAAanU,EAAO6vC,GAASS,KAAY,EAChDA,EAAOlT,WAAaA,IACtBkT,EAAOlT,SAAWA,QAGpB,GAAI5pB,EAAWq8B,GAASS,GAAStwC,GAI/B,YAHImyB,EAAGoe,gBAAkBv4C,IACvBm6B,EAAGoe,cAAgBv4C,IAMtBq4C,IACHle,EAAGoe,eAAiB,IAIxB,SAASJ,GAAqBnwC,EAAOyJ,GACnC,OAAOA,EAAQoK,OAAM,SAAUpa,GAAK,OAAQ+Z,EAAW/Z,EAAGuG,MAG5D,SAAS6vC,GAAUS,GACjB,MAAO,WAAYA,EACfA,EAAOnJ,OACPmJ,EAAOtwC,MAGb,SAAS8vC,GAAoB1sC,GAC3BA,EAAEpM,OAAOuwC,WAAY,EAGvB,SAASwI,GAAkB3sC,GAEpBA,EAAEpM,OAAOuwC,YACdnkC,EAAEpM,OAAOuwC,WAAY,EACrBiI,GAAQpsC,EAAEpM,OAAQ,UAGpB,SAASw4C,GAASrd,EAAI7zB,GACpB,IAAI8E,EAAIoe,SAASoS,YAAY,cAC7BxwB,EAAEotC,UAAUlyC,GAAM,GAAM,GACxB6zB,EAAGse,cAAcrtC,GAMnB,SAASstC,GAAY/1B,GACnB,OAAOA,EAAMhB,mBAAuBgB,EAAMre,MAASqe,EAAMre,KAAKmkC,WAE1D9lB,EADA+1B,GAAW/1B,EAAMhB,kBAAkBiU,QAIzC,IAAI4gB,GAAO,CACTr2C,KAAM,SAAeg6B,EAAI7D,EAAK3T,GAC5B,IAAI3a,EAAQsuB,EAAItuB,MAEhB2a,EAAQ+1B,GAAW/1B,GACnB,IAAIg2B,EAAgBh2B,EAAMre,MAAQqe,EAAMre,KAAKmkC,WACzCmQ,EAAkBze,EAAG0e,mBACF,SAArB1e,EAAGtsB,MAAMirC,QAAqB,GAAK3e,EAAGtsB,MAAMirC,QAC1C9wC,GAAS2wC,GACXh2B,EAAMre,KAAKkyC,MAAO,EAClB5B,GAAMjyB,GAAO,WACXwX,EAAGtsB,MAAMirC,QAAUF,MAGrBze,EAAGtsB,MAAMirC,QAAU9wC,EAAQ4wC,EAAkB,QAIjD93B,OAAQ,SAAiBqZ,EAAI7D,EAAK3T,GAChC,IAAI3a,EAAQsuB,EAAItuB,MACZu1B,EAAWjH,EAAIiH,SAGnB,IAAKv1B,KAAWu1B,EAAhB,CACA5a,EAAQ+1B,GAAW/1B,GACnB,IAAIg2B,EAAgBh2B,EAAMre,MAAQqe,EAAMre,KAAKmkC,WACzCkQ,GACFh2B,EAAMre,KAAKkyC,MAAO,EACdxuC,EACF4sC,GAAMjyB,GAAO,WACXwX,EAAGtsB,MAAMirC,QAAU3e,EAAG0e,sBAGxBjC,GAAMj0B,GAAO,WACXwX,EAAGtsB,MAAMirC,QAAU,WAIvB3e,EAAGtsB,MAAMirC,QAAU9wC,EAAQmyB,EAAG0e,mBAAqB,SAIvDE,OAAQ,SACN5e,EACAud,EACA/0B,EACAwQ,EACA2Y,GAEKA,IACH3R,EAAGtsB,MAAMirC,QAAU3e,EAAG0e,sBAKxBG,GAAqB,CACvB5kB,MAAOqjB,GACPjB,KAAMA,IAKJyC,GAAkB,CACpBn3C,KAAMhE,OACNy3C,OAAQjpC,QACRylC,IAAKzlC,QACL4sC,KAAMp7C,OACNwI,KAAMxI,OACNm0C,WAAYn0C,OACZs0C,WAAYt0C,OACZo0C,aAAcp0C,OACdu0C,aAAcv0C,OACdq0C,iBAAkBr0C,OAClBw0C,iBAAkBx0C,OAClBk3C,YAAal3C,OACbo3C,kBAAmBp3C,OACnBm3C,cAAen3C,OACf43C,SAAU,CAACzpC,OAAQnO,OAAQgD,SAK7B,SAASq4C,GAAcx2B,GACrB,IAAIy2B,EAAcz2B,GAASA,EAAMtB,iBACjC,OAAI+3B,GAAeA,EAAY15B,KAAKjO,QAAQ8iB,SACnC4kB,GAAarhB,GAAuBshB,EAAYvxC,WAEhD8a,EAIX,SAAS02B,GAAuB7iB,GAC9B,IAAIlyB,EAAO,GACPmN,EAAU+kB,EAAK5e,SAEnB,IAAK,IAAIvK,KAAOoE,EAAQ4V,UACtB/iB,EAAK+I,GAAOmpB,EAAKnpB,GAInB,IAAI0kB,EAAYtgB,EAAQukB,iBACxB,IAAK,IAAInQ,KAASkM,EAChBztB,EAAK6V,EAAS0L,IAAUkM,EAAUlM,GAEpC,OAAOvhB,EAGT,SAASg1C,GAAarxC,EAAGsxC,GACvB,GAAI,iBAAiB57C,KAAK47C,EAAS9xC,KACjC,OAAOQ,EAAE,aAAc,CACrBhC,MAAOszC,EAASl4B,iBAAiBgG,YAKvC,SAASmyB,GAAqB72B,GAC5B,MAAQA,EAAQA,EAAMrL,OACpB,GAAIqL,EAAMre,KAAKmkC,WACb,OAAO,EAKb,SAASgR,GAAap3B,EAAOq3B,GAC3B,OAAOA,EAASrsC,MAAQgV,EAAMhV,KAAOqsC,EAASjyC,MAAQ4a,EAAM5a,IAG9D,IAAIkyC,GAAgB,SAAUp7C,GAAK,OAAOA,EAAEkJ,KAAO0a,GAAmB5jB,IAElEq7C,GAAmB,SAAUjrC,GAAK,MAAkB,SAAXA,EAAE7M,MAE3C+3C,GAAa,CACf/3C,KAAM,aACNmE,MAAOgzC,GACP1kB,UAAU,EAEV3sB,OAAQ,SAAiBK,GACvB,IAAI0pB,EAAStyB,KAETwI,EAAWxI,KAAKuN,OAAOrG,QAC3B,GAAKsB,IAKLA,EAAWA,EAASm6B,OAAO2X,IAEtB9xC,EAAS3J,QAAd,CAKI,EAQJ,IAAIg7C,EAAO75C,KAAK65C,KAGZ,EASJ,IAAIK,EAAW1xC,EAAS,GAIxB,GAAI2xC,GAAoBn6C,KAAK+X,QAC3B,OAAOmiC,EAKT,IAAIl3B,EAAQ82B,GAAaI,GAEzB,IAAKl3B,EACH,OAAOk3B,EAGT,GAAIl6C,KAAKy6C,SACP,OAAOR,GAAYrxC,EAAGsxC,GAMxB,IAAIj5B,EAAK,gBAAmBjhB,KAAS,KAAI,IACzCgjB,EAAMhV,IAAmB,MAAbgV,EAAMhV,IACdgV,EAAMN,UACJzB,EAAK,UACLA,EAAK+B,EAAM5a,IACbiR,EAAY2J,EAAMhV,KACmB,IAAlCvP,OAAOukB,EAAMhV,KAAKwI,QAAQyK,GAAY+B,EAAMhV,IAAMiT,EAAK+B,EAAMhV,IAC9DgV,EAAMhV,IAEZ,IAAI/I,GAAQ+d,EAAM/d,OAAS+d,EAAM/d,KAAO,KAAKmkC,WAAa4Q,GAAsBh6C,MAC5E06C,EAAc16C,KAAKu2B,OACnB8jB,EAAWP,GAAaY,GAQ5B,GAJI13B,EAAM/d,KAAKgiB,YAAcjE,EAAM/d,KAAKgiB,WAAW/a,KAAKquC,MACtDv3B,EAAM/d,KAAKkyC,MAAO,GAIlBkD,GACAA,EAASp1C,OACRm1C,GAAYp3B,EAAOq3B,KACnBv3B,GAAmBu3B,MAElBA,EAAS/3B,oBAAqB+3B,EAAS/3B,kBAAkBiU,OAAO7T,WAClE,CAGA,IAAI2rB,EAAUgM,EAASp1C,KAAKmkC,WAAavtB,EAAO,GAAI5W,GAEpD,GAAa,WAAT40C,EAOF,OALA75C,KAAKy6C,UAAW,EAChB3uB,GAAeuiB,EAAS,cAAc,WACpC/b,EAAOmoB,UAAW,EAClBnoB,EAAO8F,kBAEF6hB,GAAYrxC,EAAGsxC,GACjB,GAAa,WAATL,EAAmB,CAC5B,GAAI/2B,GAAmBE,GACrB,OAAO03B,EAET,IAAIC,EACA9C,EAAe,WAAc8C,KACjC7uB,GAAe7mB,EAAM,aAAc4yC,GACnC/rB,GAAe7mB,EAAM,iBAAkB4yC,GACvC/rB,GAAeuiB,EAAS,cAAc,SAAUkJ,GAASoD,EAAepD,MAI5E,OAAO2C,KAMPtzC,GAAQiV,EAAO,CACjBzT,IAAK3J,OACLm8C,UAAWn8C,QACVm7C,WAEIhzC,GAAMizC,KAEb,IAAIgB,GAAkB,CACpBj0C,MAAOA,GAEPk0C,YAAa,WACX,IAAIxoB,EAAStyB,KAETyhB,EAASzhB,KAAKm6B,QAClBn6B,KAAKm6B,QAAU,SAAU7W,EAAOgQ,GAC9B,IAAIiH,EAAwBd,GAAkBnH,GAE9CA,EAAOkI,UACLlI,EAAOiE,OACPjE,EAAOyoB,MACP,GACA,GAEFzoB,EAAOiE,OAASjE,EAAOyoB,KACvBxgB,IACA9Y,EAAO1iB,KAAKuzB,EAAQhP,EAAOgQ,KAI/B/qB,OAAQ,SAAiBK,GAQvB,IAPA,IAAIR,EAAMpI,KAAKoI,KAAOpI,KAAK+X,OAAO9S,KAAKmD,KAAO,OAC1C+R,EAAM1Y,OAAO2Y,OAAO,MACpB4gC,EAAeh7C,KAAKg7C,aAAeh7C,KAAKwI,SACxCyyC,EAAcj7C,KAAKuN,OAAOrG,SAAW,GACrCsB,EAAWxI,KAAKwI,SAAW,GAC3B0yC,EAAiBlB,GAAsBh6C,MAElCW,EAAI,EAAGA,EAAIs6C,EAAYp8C,OAAQ8B,IAAK,CAC3C,IAAIzB,EAAI+7C,EAAYt6C,GACpB,GAAIzB,EAAEkJ,IACJ,GAAa,MAATlJ,EAAE8O,KAAoD,IAArCvP,OAAOS,EAAE8O,KAAKwI,QAAQ,WACzChO,EAAS1D,KAAK5F,GACdib,EAAIjb,EAAE8O,KAAO9O,GACXA,EAAE+F,OAAS/F,EAAE+F,KAAO,KAAKmkC,WAAa8R,QAS9C,GAAIF,EAAc,CAGhB,IAFA,IAAID,EAAO,GACPI,EAAU,GACL7hB,EAAM,EAAGA,EAAM0hB,EAAan8C,OAAQy6B,IAAO,CAClD,IAAI8hB,EAAMJ,EAAa1hB,GACvB8hB,EAAIn2C,KAAKmkC,WAAa8R,EACtBE,EAAIn2C,KAAKo2C,IAAMD,EAAIr5B,IAAIu5B,wBACnBnhC,EAAIihC,EAAIptC,KACV+sC,EAAKj2C,KAAKs2C,GAEVD,EAAQr2C,KAAKs2C,GAGjBp7C,KAAK+6C,KAAOnyC,EAAER,EAAK,KAAM2yC,GACzB/6C,KAAKm7C,QAAUA,EAGjB,OAAOvyC,EAAER,EAAK,KAAMI,IAGtB+yC,QAAS,WACP,IAAI/yC,EAAWxI,KAAKg7C,aAChBJ,EAAY56C,KAAK46C,YAAe56C,KAAKyC,MAAQ,KAAO,QACnD+F,EAAS3J,QAAWmB,KAAKw7C,QAAQhzC,EAAS,GAAGuZ,IAAK64B,KAMvDpyC,EAAS/D,QAAQg3C,IACjBjzC,EAAS/D,QAAQi3C,IACjBlzC,EAAS/D,QAAQk3C,IAKjB37C,KAAK47C,QAAUzxB,SAAS0xB,KAAKC,aAE7BtzC,EAAS/D,SAAQ,SAAUvF,GACzB,GAAIA,EAAE+F,KAAK82C,MAAO,CAChB,IAAIjhB,EAAK57B,EAAE6iB,IACPuzB,EAAIxa,EAAGtsB,MACXwlC,GAAmBlZ,EAAI8f,GACvBtF,EAAE0G,UAAY1G,EAAE2G,gBAAkB3G,EAAE4G,mBAAqB,GACzDphB,EAAG/a,iBAAiBuzB,GAAoBxY,EAAGqhB,QAAU,SAAS5xB,EAAIxe,GAC5DA,GAAKA,EAAEpM,SAAWm7B,GAGjB/uB,IAAK,aAAazN,KAAKyN,EAAEqwC,gBAC5BthB,EAAGqT,oBAAoBmF,GAAoB/oB,GAC3CuQ,EAAGqhB,QAAU,KACbjI,GAAsBpZ,EAAI8f,YAOpCxtC,QAAS,CACPouC,QAAS,SAAkB1gB,EAAI8f,GAE7B,IAAK1H,GACH,OAAO,EAGT,GAAIlzC,KAAKq8C,SACP,OAAOr8C,KAAKq8C,SAOd,IAAIlpB,EAAQ2H,EAAGwhB,YACXxhB,EAAG0T,oBACL1T,EAAG0T,mBAAmB/pC,SAAQ,SAAU6pC,GAAOiE,GAAYpf,EAAOmb,MAEpE+D,GAASlf,EAAOynB,GAChBznB,EAAM3kB,MAAMirC,QAAU,OACtBz5C,KAAKq6B,IAAIuM,YAAYzT,GACrB,IAAItK,EAAOwrB,GAAkBlhB,GAE7B,OADAnzB,KAAKq6B,IAAIsM,YAAYxT,GACbnzB,KAAKq8C,SAAWxzB,EAAKqsB,gBAKnC,SAASuG,GAAgBv8C,GAEnBA,EAAE6iB,IAAIo6B,SACRj9C,EAAE6iB,IAAIo6B,UAGJj9C,EAAE6iB,IAAI2zB,UACRx2C,EAAE6iB,IAAI2zB,WAIV,SAASgG,GAAgBx8C,GACvBA,EAAE+F,KAAKs3C,OAASr9C,EAAE6iB,IAAIu5B,wBAGxB,SAASK,GAAkBz8C,GACzB,IAAIs9C,EAASt9C,EAAE+F,KAAKo2C,IAChBkB,EAASr9C,EAAE+F,KAAKs3C,OAChBE,EAAKD,EAAO/vC,KAAO8vC,EAAO9vC,KAC1BiwC,EAAKF,EAAOG,IAAMJ,EAAOI,IAC7B,GAAIF,GAAMC,EAAI,CACZx9C,EAAE+F,KAAK82C,OAAQ,EACf,IAAIzG,EAAIp2C,EAAE6iB,IAAIvT,MACd8mC,EAAE0G,UAAY1G,EAAE2G,gBAAkB,aAAeQ,EAAK,MAAQC,EAAK,MACnEpH,EAAE4G,mBAAqB,MAI3B,IAAIU,GAAqB,CACvBpC,WAAYA,GACZK,gBAAiBA,IAMnB/jB,GAAI9yB,OAAOia,YAAcA,GACzB6Y,GAAI9yB,OAAO4Z,cAAgBA,GAC3BkZ,GAAI9yB,OAAO6Z,eAAiBA,GAC5BiZ,GAAI9yB,OAAO+Z,gBAAkBA,GAC7B+Y,GAAI9yB,OAAO8Z,iBAAmBA,GAG9BjC,EAAOib,GAAI1kB,QAAQ6U,WAAY0yB,IAC/B99B,EAAOib,GAAI1kB,QAAQ0uB,WAAY8b,IAG/B9lB,GAAI51B,UAAUs5B,UAAYzb,EAAYk5B,GAAQj8B,EAG9C8a,GAAI51B,UAAU2yB,OAAS,SACrBiH,EACAxH,GAGA,OADAwH,EAAKA,GAAM/b,EAAY+mB,GAAMhL,QAAMh8B,EAC5B+7B,GAAe76B,KAAM86B,EAAIxH,IAK9BvU,GACF8K,YAAW,WACL7lB,EAAOsZ,UACLA,IACFA,GAAS2f,KAAK,OAAQnG,MAsBzB,GAKU,Y,0DCjwQf,IAAIz3B,EAAI,EAAQ,QACZ6D,EAA2B,EAAQ,QAAmD7B,EACtF7B,EAAW,EAAQ,QACnB4W,EAAa,EAAQ,QACrBrN,EAAyB,EAAQ,QACjCsN,EAAuB,EAAQ,QAC/BwmC,EAAU,EAAQ,QAGlBC,EAAc,GAAGC,WACjBjzC,EAAM3E,KAAK2E,IAEXkzC,EAA0B3mC,EAAqB,cAE/C4mC,GAAoBJ,IAAYG,KAA6B,WAC/D,IAAIzpC,EAAarQ,EAAyBzE,OAAOyC,UAAW,cAC5D,OAAOqS,IAAeA,EAAWiL,SAF8B,GAOjEnf,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,QAASusC,IAAqBD,GAA2B,CAC1FD,WAAY,SAAoBxmC,GAC9B,IAAI3X,EAAOH,OAAOsK,EAAuB/I,OACzCoW,EAAWG,GACX,IAAIlL,EAAQ7L,EAASsK,EAAI1K,UAAUP,OAAS,EAAIO,UAAU,QAAKN,EAAWF,EAAKC,SAC3Eq+C,EAASz+C,OAAO8X,GACpB,OAAOumC,EACHA,EAAY/9C,KAAKH,EAAMs+C,EAAQ7xC,GAC/BzM,EAAKwB,MAAMiL,EAAOA,EAAQ6xC,EAAOr+C,UAAYq+C,M,uBC9BrD,IAiBIC,EAAOC,EAASC,EAjBhBvtC,EAAS,EAAQ,QACjB1J,EAAQ,EAAQ,QAChBtF,EAAO,EAAQ,QACfw8C,EAAO,EAAQ,QACfj3C,EAAgB,EAAQ,QACxBk3C,EAAS,EAAQ,QACjBC,EAAU,EAAQ,QAElBC,EAAW3tC,EAAO2tC,SAClB78B,EAAM9Q,EAAOia,aACblJ,EAAQ/Q,EAAO4tC,eACflpC,EAAU1E,EAAO0E,QACjBmpC,EAAiB7tC,EAAO6tC,eACxBC,EAAW9tC,EAAO8tC,SAClB5zB,EAAU,EACV+R,EAAQ,GACR8hB,EAAqB,qBAGrBjhB,EAAM,SAAU3b,GAElB,GAAI8a,EAAMthB,eAAewG,GAAK,CAC5B,IAAItiB,EAAKo9B,EAAM9a,UACR8a,EAAM9a,GACbtiB,MAIAm/C,EAAS,SAAU78B,GACrB,OAAO,WACL2b,EAAI3b,KAIJ88B,EAAW,SAAUnyB,GACvBgR,EAAIhR,EAAM3mB,OAGR+4C,EAAO,SAAU/8B,GAEnBnR,EAAOmuC,YAAYh9B,EAAK,GAAIw8B,EAASS,SAAW,KAAOT,EAASU,OAI7Dv9B,GAAQC,IACXD,EAAM,SAAsBjiB,GAC1B,IAAI8B,EAAO,GACPE,EAAI,EACR,MAAOvB,UAAUP,OAAS8B,EAAGF,EAAKqE,KAAK1F,UAAUuB,MAMjD,OALAo7B,IAAQ/R,GAAW,YAEH,mBAANrrB,EAAmBA,EAAKiC,SAASjC,IAAKQ,WAAML,EAAW2B,IAEjE08C,EAAMnzB,GACCA,GAETnJ,EAAQ,SAAwBI,UACvB8a,EAAM9a,IAGXu8B,EACFL,EAAQ,SAAUl8B,GAChBzM,EAAQ8V,SAASwzB,EAAO78B,KAGjB28B,GAAYA,EAASthB,IAC9B6gB,EAAQ,SAAUl8B,GAChB28B,EAASthB,IAAIwhB,EAAO78B,KAIb08B,IAAmBJ,GAC5BH,EAAU,IAAIO,EACdN,EAAOD,EAAQgB,MACfhB,EAAQiB,MAAMC,UAAYP,EAC1BZ,EAAQr8C,EAAKu8C,EAAKY,YAAaZ,EAAM,IAIrCvtC,EAAOiQ,kBACe,mBAAfk+B,cACNnuC,EAAOyuC,eACRd,GAAkC,UAAtBA,EAASS,WACpB93C,EAAM43C,IAEPb,EAAQa,EACRluC,EAAOiQ,iBAAiB,UAAWg+B,GAAU,IAG7CZ,EADSU,KAAsBx3C,EAAc,UACrC,SAAU4a,GAChBq8B,EAAK1W,YAAYvgC,EAAc,WAAWw3C,GAAsB,WAC9DP,EAAK3W,YAAY3mC,MACjB48B,EAAI3b,KAKA,SAAUA,GAChB4I,WAAWi0B,EAAO78B,GAAK,KAK7B1iB,EAAOC,QAAU,CACfoiB,IAAKA,EACLC,MAAOA,I,uBCzGT,IAMI7a,EAAOg+B,EANPl0B,EAAS,EAAQ,QACjBwB,EAAY,EAAQ,QAEpBkD,EAAU1E,EAAO0E,QACjBgqC,EAAWhqC,GAAWA,EAAQgqC,SAC9BC,EAAKD,GAAYA,EAASC,GAG1BA,GACFz4C,EAAQy4C,EAAGr0C,MAAM,KACjB45B,EAAUh+B,EAAM,GAAK,EAAI,EAAIA,EAAM,GAAKA,EAAM,IACrCsL,IACTtL,EAAQsL,EAAUtL,MAAM,iBACnBA,GAASA,EAAM,IAAM,MACxBA,EAAQsL,EAAUtL,MAAM,iBACpBA,IAAOg+B,EAAUh+B,EAAM,MAI/BzH,EAAOC,QAAUwlC,IAAYA,G,oCCjB7B,IAAI0a,EAAe,EAAQ,QAY3BngD,EAAOC,QAAU,SAAqBmgD,EAAS36C,EAAQ46C,EAAM96C,EAASC,GACpE,IAAIlC,EAAQ,IAAIg9C,MAAMF,GACtB,OAAOD,EAAa78C,EAAOmC,EAAQ46C,EAAM96C,EAASC,K,oCCdpDxF,EAAOC,QAAU,SAAkBmK,GACjC,SAAUA,IAASA,EAAMm2C,c,oCCH3B,0BAGe,sBAAuB,SAAU,MAAhD,a,oCCDA,IAAIt7C,EAAQ,EAAQ,QAEpB,SAASu7C,EAAOh3C,GACd,OAAOi3C,mBAAmBj3C,GACxB3C,QAAQ,QAAS,KACjBA,QAAQ,QAAS,KACjBA,QAAQ,OAAQ,KAChBA,QAAQ,QAAS,KACjBA,QAAQ,OAAQ,KAChBA,QAAQ,QAAS,KACjBA,QAAQ,QAAS,KAUrB7G,EAAOC,QAAU,SAAkB0F,EAAK2nB,EAAQozB,GAE9C,IAAKpzB,EACH,OAAO3nB,EAGT,IAAIg7C,EACJ,GAAID,EACFC,EAAmBD,EAAiBpzB,QAC/B,GAAIroB,EAAM0R,kBAAkB2W,GACjCqzB,EAAmBrzB,EAAOvqB,eACrB,CACL,IAAI69C,EAAQ,GAEZ37C,EAAMiB,QAAQonB,GAAQ,SAAmB9jB,EAAKiG,GAChC,OAARjG,GAA+B,qBAARA,IAIvBvE,EAAMsW,QAAQ/R,GAChBiG,GAAY,KAEZjG,EAAM,CAACA,GAGTvE,EAAMiB,QAAQsD,GAAK,SAAoBkR,GACjCzV,EAAM47C,OAAOnmC,GACfA,EAAIA,EAAEomC,cACG77C,EAAMrD,SAAS8Y,KACxBA,EAAI9D,KAAKC,UAAU6D,IAErBkmC,EAAMr6C,KAAKi6C,EAAO/wC,GAAO,IAAM+wC,EAAO9lC,WAI1CimC,EAAmBC,EAAMt+C,KAAK,KAOhC,OAJIq+C,IACFh7C,KAA8B,IAAtBA,EAAIsS,QAAQ,KAAc,IAAM,KAAO0oC,GAG1Ch7C,I,qBChET,IAAI7E,EAAI,EAAQ,QACZ+G,EAAQ,EAAQ,QAChB7G,EAAW,EAAQ,QACnB+/C,EAAuB,EAAQ,QAC/BC,EAA2B,EAAQ,QAEnCC,EAAsBp5C,GAAM,WAAck5C,EAAqB,MAInEjgD,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,OAAQ8uC,EAAqB5rC,MAAO2rC,GAA4B,CAChGE,eAAgB,SAAwB79C,GACtC,OAAO09C,EAAqB//C,EAASqC,Q,uBCZzC,IAAIiP,EAAa,EAAQ,QAEzBtS,EAAOC,QAAUqS,EAAW,YAAa,cAAgB,I,uBCFzD,IAAInB,EAAU,EAAQ,QAClBgwC,EAAY,EAAQ,QACpBthD,EAAkB,EAAQ,QAE1B0S,EAAW1S,EAAgB,YAE/BG,EAAOC,QAAU,SAAUoD,GACzB,QAAU9C,GAAN8C,EAAiB,OAAOA,EAAGkP,IAC1BlP,EAAG,eACH89C,EAAUhwC,EAAQ9N,M,gDCTzB,IAAIe,EAAc,EAAQ,QACtBqU,EAAuB,EAAQ,QAC/B1N,EAAW,EAAQ,QACnBq2C,EAAa,EAAQ,QAKzBphD,EAAOC,QAAUmE,EAAclB,OAAOwhB,iBAAmB,SAA0BljB,EAAG6/C,GACpFt2C,EAASvJ,GACT,IAGIiO,EAHA4O,EAAO+iC,EAAWC,GAClB/gD,EAAS+d,EAAK/d,OACdwM,EAAQ,EAEZ,MAAOxM,EAASwM,EAAO2L,EAAqB3V,EAAEtB,EAAGiO,EAAM4O,EAAKvR,KAAUu0C,EAAW5xC,IACjF,OAAOjO,I,kCCfM,SAAS8/C,EAAgB99C,GACtC,GAAIG,MAAM4X,QAAQ/X,GAAM,OAAOA,E,8FCDlB,SAAS+9C,EAAsB/9C,EAAKpB,GACjD,IAAI8wB,EAAK1vB,IAA0B,qBAAXye,QAA0Bze,EAAIye,OAAOnO,WAAatQ,EAAI,eAE9E,GAAU,MAAN0vB,EAAJ,CACA,IAIIJ,EAAIU,EAJJguB,EAAO,GACP3uB,GAAK,EACLc,GAAK,EAIT,IACE,IAAKT,EAAKA,EAAG1yB,KAAKgD,KAAQqvB,GAAMC,EAAKI,EAAGvgB,QAAQzF,MAAO2lB,GAAK,EAG1D,GAFA2uB,EAAKj7C,KAAKusB,EAAG1oB,OAEThI,GAAKo/C,EAAKlhD,SAAW8B,EAAG,MAE9B,MAAOioB,GACPsJ,GAAK,EACLH,EAAKnJ,EARP,QAUE,IACOwI,GAAsB,MAAhBK,EAAG,WAAmBA,EAAG,YADtC,QAGE,GAAIS,EAAI,MAAMH,GAIlB,OAAOguB,G,gBC3BM,SAASC,IACtB,MAAM,IAAInwC,UAAU,6ICGP,SAASowC,EAAel+C,EAAKpB,GAC1C,OAAOu/C,EAAen+C,IAAQo+C,EAAqBp+C,EAAKpB,IAAMy/C,eAA2Br+C,EAAKpB,IAAM0/C,M,oCCOtG9hD,EAAOC,QAAU,SAAsBqD,EAAOmC,EAAQ46C,EAAM96C,EAASC,GAOnE,OANAlC,EAAMmC,OAASA,EACX46C,IACF/8C,EAAM+8C,KAAOA,GAEf/8C,EAAMiC,QAAUA,EAChBjC,EAAMkC,SAAWA,EACVlC,I,uBCnBT,IAAIxC,EAAI,EAAQ,QACZihD,EAAS,EAAQ,QAIrBjhD,EAAE,CAAEM,OAAQ,SAAUC,OAAO,GAAQ,CACnC0gD,OAAQA,K,kCCJV,IAAI98C,EAAQ,EAAQ,QAEpBjF,EAAOC,QACLgF,EAAM+8C,uBAIN,WACE,IAEIC,EAFAC,EAAO,kBAAkBniD,KAAK+gB,UAAU/N,WACxCovC,EAAiBv2B,SAAS9jB,cAAc,KAS5C,SAASs6C,EAAWz8C,GAClB,IAAI08C,EAAO18C,EAWX,OATIu8C,IAEFC,EAAeta,aAAa,OAAQwa,GACpCA,EAAOF,EAAeE,MAGxBF,EAAeta,aAAa,OAAQwa,GAG7B,CACLA,KAAMF,EAAeE,KACrB1C,SAAUwC,EAAexC,SAAWwC,EAAexC,SAAS94C,QAAQ,KAAM,IAAM,GAChF+4C,KAAMuC,EAAevC,KACrBjB,OAAQwD,EAAexD,OAASwD,EAAexD,OAAO93C,QAAQ,MAAO,IAAM,GAC3EknB,KAAMo0B,EAAep0B,KAAOo0B,EAAep0B,KAAKlnB,QAAQ,KAAM,IAAM,GACpEy7C,SAAUH,EAAeG,SACzBxD,KAAMqD,EAAerD,KACrByD,SAAiD,MAAtCJ,EAAeI,SAAS36C,OAAO,GAChCu6C,EAAeI,SACf,IAAMJ,EAAeI,UAYnC,OARAN,EAAYG,EAAWn/C,OAAOi8C,SAASmD,MAQhC,SAAyBG,GAC9B,IAAIC,EAAUx9C,EAAMy9C,SAASF,GAAeJ,EAAWI,GAAcA,EACrE,OAAQC,EAAO9C,WAAasC,EAAUtC,UAChC8C,EAAO7C,OAASqC,EAAUrC,MAhDpC,GAqDA,WACE,OAAO,WACL,OAAO,GAFX,I,uBC9DF,IAAIh+C,EAAW,EAAQ,QAEvB5B,EAAOC,QAAU,SAAUoD,GACzB,IAAKzB,EAASyB,IAAc,OAAPA,EACnB,MAAMiO,UAAU,aAAepR,OAAOmD,GAAM,mBAC5C,OAAOA,I,oCCJX,IAAIuE,EAAS,EAAQ,QAAiCA,OAClD+6C,EAAsB,EAAQ,QAC9BC,EAAiB,EAAQ,QAEzBC,EAAkB,kBAClBC,EAAmBH,EAAoBtgC,IACvC0gC,EAAmBJ,EAAoBK,UAAUH,GAIrDD,EAAe1iD,OAAQ,UAAU,SAAU+iD,GACzCH,EAAiBrhD,KAAM,CACrBiH,KAAMm6C,EACN72C,OAAQ9L,OAAO+iD,GACfn2C,MAAO,OAIR,WACD,IAGIo2C,EAHAC,EAAQJ,EAAiBthD,MACzBuK,EAASm3C,EAAMn3C,OACfc,EAAQq2C,EAAMr2C,MAElB,OAAIA,GAASd,EAAO1L,OAAe,CAAE8J,WAAO7J,EAAW2M,MAAM,IAC7Dg2C,EAAQt7C,EAAOoE,EAAQc,GACvBq2C,EAAMr2C,OAASo2C,EAAM5iD,OACd,CAAE8J,MAAO84C,EAAOh2C,MAAM,Q,uBC3B/B,IAAIpM,EAAI,EAAQ,QACZsiD,EAAO,EAAQ,QAEfC,EAAMz8C,KAAKy8C,IACXC,EAAM18C,KAAK08C,IAIfxiD,EAAE,CAAEM,OAAQ,OAAQ2D,MAAM,GAAQ,CAChCw+C,KAAM,SAAcC,GAClB,OAAOJ,EAAKI,GAAKA,GAAKF,EAAID,EAAIG,GAAI,EAAI,O,qBCV1CxjD,EAAOC,QAAU,I,uBCAjB,IAAIkR,EAAU,EAAQ,QAItBnR,EAAOC,QAAU,SAAUmK,GACzB,GAAoB,iBAATA,GAAuC,UAAlB+G,EAAQ/G,GACtC,MAAMkH,UAAU,wBAElB,OAAQlH,I,sKCSK,EAAAq5C,EAAA,YAAc,CAC3Bv/C,KAD2B,YAG3BmE,MAAO,CACLq7C,SADK,QAELC,OAFK,QAGLC,SAHK,QAIL95C,MAJK,QAKL+5C,SALK,QAMLC,gBAAiB,CACfn7C,QADe,GAEfD,KAAM,CAAC2F,OAAQnO,SAEjBoB,KAVK,QAWLyiD,SAXK,QAYLC,UAZK,QAaLC,MAbK,QAcL/9B,IAAK,CACHxd,KAAM,CAACxI,OADJ,QAEHyI,QAAS,IAEXkB,IAAK,CACHnB,KADG,OAEHC,QAAS,WAIbjC,KAAM,iBAAO,CACXw9C,YAAY,IAGd31C,SAAU,CACR41C,eADQ,WAEN,IAAMj0C,EAASzO,KAAf,sBAEA,IAAKA,KAAL,WAAsB,OAAOyO,EAE7B,IAAM4zC,EAAkB7e,SAASxjC,KAAjC,iBAEA,OAAOA,KAAK2iD,YAAL,EAEHl0C,GAAWuL,MAAD,GAFd,EAEc,IAEhB4oC,sBAZQ,WAaN,OAAI5iD,KAAJ,OAAwBwjC,SAASxjC,KAAhB,QACbA,KAAK6iD,aAAe7iD,KAAxB,MAA2C,GACvCA,KAAK6iD,aAAe7iD,KAAxB,MAA2C,IACvCA,KAAJ,YAA6B,IACzBA,KAAJ,MAAuB,GACnBA,KAAKwiD,OAASxiD,KAAK8iD,SAAS96C,WAAhC,UAA6D,GAC7D,IAEF+6C,QArBQ,WAsBN,wCACKf,EAAA,mCADE,OAAP,IAEE,aAFK,EAGL,sBAAuBhiD,KAHlB,SAIL,oBAAqBA,KAJhB,OAKL,sBAAuBA,KALlB,SAML,uBAAwBA,KANnB,YAOL,mBAAoBA,KAPf,MAQL,sBAAuBA,KARlB,WASL,kBAAmBA,KATd,KAUL,sBAAuBA,KAVlB,SAWL,uBAAwBA,KAAK6iD,eAGjCF,YApCQ,WAqCN,OAAO3iD,KAAP,UAEF6iD,YAvCQ,WAwCN,OAAO7iD,KAAP,WAEFmW,OA1CQ,WA2CN,wCACKnW,KADE,kBAAP,IAEEyO,OAAQ,eAAczO,KAAD,oBAK3BojC,QAjF2B,WAiFpB,WACC4f,EAAgB,CACpB,CAAC,MADmB,mBAEpB,CAAC,gBAFmB,8BAGpB,CAAC,eAHmB,4BAIpB,CAAC,gBAJmB,6BAKpB,CAAC,kBALmB,+BAMpB,CAAC,oBANmB,iCAOpB,CAAC,gBAPmB,6BAQpB,CAAC,mBARmB,gCASpB,CAAC,OATH,qBAaAA,EAAA,SAAsB,YAA4B,0BAA3B,EAA2B,KAA5B,EAA4B,KAC5C,wBAAJ,IAA0C,eAASr/B,EAAU/d,EAAnB,OAI9CwH,QAAS,CACP61C,cADO,WAEL,IAAMr8C,EAAQ,CACZ6H,OAAQ,eAAczO,KADV,gBAEZykB,IAAKzkB,KAAKykB,KAGNy+B,EAAQljD,KAAK6uB,aAAas0B,IAC5BnjD,KAAK6uB,aAAas0B,IAAI,CAAEv8C,UACxB5G,KAAK8uB,eAAes0B,EAApB,KAA0B,CAAEx8C,UAEhC,OAAO5G,KAAK8uB,eAAe,MAAO,CAChCjmB,YAAa,oBACZ,CAFH,KAIFw6C,WAfO,WAgBL,OAAOrjD,KAAK8uB,eAAe,MAAO,CAChCjmB,YADgC,qBAEhC2F,MAAO,CACLC,OAAQ,eAAczO,KAAD,yBAEtB,eALH,QAOFsjD,aAvBO,WAwBL,OAAOtjD,KAAK8uB,eAAe,MAAO,CAChCjmB,YADgC,uBAEhC2F,MAAO,CACLC,OAAQ,eAAczO,KAAD,mBAEtB,eAAQA,KALX,gBASJuI,OArI2B,SAqIrB,GACJvI,KAAA,WAAkBA,KAAKoiD,YAAcpiD,KAAK6uB,aAA1C,UAEA,IAAMrmB,EAAW,CAACxI,KAAlB,cACMiF,EAAOjF,KAAKujD,mBAAmBvjD,KAAxB,MAAoC,CAC/C8I,MAAO9I,KADwC,QAE/CwO,MAAOxO,KAFwC,OAG/CoO,GAAIpO,KAAKw7B,aAMX,OAHIx7B,KAAJ,YAAqBwI,EAAA,KAAcxI,KAAd,iBACjBA,KAAKykB,KAAOzkB,KAAK6uB,aAArB,MAAuCrmB,EAAA,QAAiBxI,KAAjB,iBAEhC4I,EAAE5I,KAAD,MAAR,M,YCtJJ,SAAS4jB,EAAT,KACE,MAAyBy0B,EAAA,WAAzB,OAAQmL,YAAR,SACM76C,EAAQ0vC,EAAd,MACMjmC,EAAW,8BAA6BzJ,EAA9B,SAAgD,CAAEsiB,SAAS,GACrE9B,EAA2B,oBAAVxgB,GAAwB,gBAA/B,IAAgEA,EAAhF,QAEMhJ,EAAS6jD,EAAI,EAEfnL,EAAA,IACEluB,SAAA,cAAuBkuB,EADzB,KAFJ,OAMA,IAEA14C,EAAA,+BAEAm7B,EAAA,UAAe,CACb3R,UACA/W,UAEAzS,OAAQ6jD,OAAO1kD,EAAYa,IAI/B,SAAS+5C,EAAT,GACE,GAAK5e,EAAL,WAEA,MAA0CA,EAA1C,UAAM,EAAN,EAAM,UAAN,EAAM,QAAN,IAA0Bn7B,cAA1B,MAAmCm7B,EAAnC,EAEAn7B,EAAA,yCACOm7B,EAAP,WAGK,IAAM2oB,EAAS,CACpB7/B,WACA81B,UAGF,I,wBC7Cc,cAAmE,IAArBhK,EAAqB,uDAAnE,GAEZ,OAAO,OAAApoB,EAAA,MAAO,eAAoB,CAAC,WAA5B,kBAA0D,CAC/D7kB,KAD+D,kBAG/DmE,MAAO,CACL88C,IAAKz2C,SAGPH,SAAU,CACR62C,oBADQ,WAEN,WAIJ/jC,MAAO,CAGL8jC,IAHK,SAGF,KACDE,EACI5jD,KAAK6jD,mBADL,GAEA7jD,KAFJ,cAIF2jD,oBARK,SAQc,KACjB3jD,KAAA,gCAAqCA,KAArC,UAIJ8jD,UA1B+D,WA2B7D9jD,KAAA,cAGFojC,QA9B+D,WA+B7D,IAAK,IAAIziC,EAAJ,EAAW9B,EAAS6wC,EAAzB,OAAwC/uC,EAAxC,EAAoDA,IAClDX,KAAA,OAAY0vC,EAAZ,GAAuB1vC,KAAvB,YAEFA,KAAA,cAGFsjC,QArC+D,WAsC7DtjC,KAAA,cAGF+jD,YAzC+D,WA0C7D/jD,KAAA,qBAGFqjC,UA7C+D,WA8C7DrjC,KAAA,qBAGFoN,QAAS,CACP42C,WADO,WAEAhkD,KAAL,KAEAA,KAAA,8BACEA,KADF,KAEEA,KAFF,oBAGEA,KAHF,sBAMF6jD,kBAVO,WAUyB,IAAbxtB,EAAa,yDACzBA,GAAUr2B,KAAf,MAEAA,KAAA,gCACEA,KADF,KAEEA,KAFF,sBAKFikD,kBAAmB,kBAAM,M,gBCzDhB,gBAAW,CACxBxhD,KADwB,aAGxBwkB,WAAY,CAAEw8B,UAEd78C,MAAO,CACLs9C,aADK,OAELC,gBAAiB,CAAC1lD,OAAQmO,SAG5B3H,KAAM,iBAAO,CACXm/C,cADW,EAEXC,iBAFW,EAGXC,UAHW,EAIXC,eAJW,EAKXC,eALW,EAMXC,YANW,EAOX9kD,OAAQ,OAGVmN,SAAU,CAMR43C,UANQ,WAON,2BAAcljD,QAMhBmjD,wBAbQ,WAcN,OAAO3kD,KAAKmkD,gBACRv3C,OAAO5M,KADJ,iBAAP,MAMJ4f,MAAO,CACL2kC,cADK,WAEHvkD,KAAA,YAAmBA,KAAKykD,aAAezkD,KAAvC,eAEFskD,SAJK,WAKHtkD,KAAA,gBAIJsjC,QAjDwB,WAkDlBtjC,KAAJ,eACEA,KAAA,OAAcmqB,SAAA,cAAuBnqB,KAArC,cAEKA,KAAL,QACE,OAAAspB,EAAA,MAAY,4CAAD,OAA6CtpB,KAA7C,cAAX,QAKNoN,QAAS,CACPw3C,SADO,WACC,WACD5kD,KAAL,YAEAA,KAAA,eAAsBA,KAAtB,cACAA,KAAA,cAAqBA,KAAKL,OACtBK,KAAKL,OADY,UAEjB6B,OAFJ,YAIAxB,KAAA,cAAqBA,KAAKokD,cAAgBpkD,KAA1C,eACAA,KAAA,iBAAwBmF,KAAA,IAASnF,KAAKokD,cAAgBpkD,KAAtD,yBAEAA,KAAA,WAAe,WAEXmF,KAAA,IAAS,gBAAqB,EAA9B,aACA,EAFF,yBAGE,sBAQN0/C,aAxBO,gB,wBCvDLC,EAAa,OAAAx9B,EAAA,MAAO,EAAD,gBAKvB,EAAgB,MAAO,CAAC,cAAD,4EALzB,WAiBe,OAAAw9B,EAAA,OAAkB,CAC/BriD,KAD+B,YAG/BwkB,WAAY,CAAEw8B,OAAA,GAEd/8B,QAL+B,WAM7B,MAAO,CAAEq+B,QAAS/kD,OAGpB4G,MAAO,CACLo+C,YADK,QAELC,aAFK,QAGLC,iBAHK,QAILC,gBAJK,QAKLC,gBALK,QAMLC,aANK,QAOLC,eAPK,QAQLC,gBARK,QASLC,eATK,QAUL78C,MAAO,CACL1B,KADK,QAELC,SAAS,IAIbjC,KAzB+B,WA0B7B,MAAO,CACLq/C,SAAUtkD,KAAK2I,QAInBmE,SAAU,CACR62C,oBADQ,WAEN,OAAQ3jD,KAAD,OAAP,SAAO,OAET0kD,UAJQ,WAKN,OACE,0CAEE1kD,KAAKslD,gBACLtlD,KADA,iBAEAA,KAFA,cAGAA,KAHA,kBAIAA,KAJA,WAQCA,KAXL,QAeF+iD,QApBQ,WAqBN,wCACK,gCADE,OAAP,IAEE,sBAAuB/iD,KAAKmiD,UAAYniD,KAFnC,iBAGL,aAHK,EAIL,qBAAsBA,KAAKglD,aAAehlD,KAJrC,aAKL,gCAAiCA,KAL5B,gBAML,+BAAgCA,KAN3B,gBAOL,oBAAqBA,KAAD,WAAmBA,KAAK0jD,KAAO1jD,KAP9C,OAQL,yBAA0BA,KARrB,WASL,yBAA0BA,KAAKokD,cAT1B,EAUL,8BAA+BpkD,KAAKwlD,kBAGxCC,YAlCQ,WAmCN,IAAMC,EAAY1lD,KAAlB,wBACA,OAAOmF,KAAA,KAAUugD,EAAY1lD,KAAb,eAAT,EAAP,IAEF4iD,sBAtCQ,WAuCN,IAAK5iD,KAAL,eAA0B,OAAO,8CAAP,MAE1B,IAAM8J,EAAM9J,KAAKqI,MAAQ,GAAzB,GACMyK,EAAM9S,KAAZ,uBAEA,OAAO8J,GAAOgJ,EAAD,GAAc9S,KAA3B,aAEF2lD,iBA9CQ,WA+CN,GAAK3lD,KAAL,aAEA,IAAM8J,EAAN,KACMgJ,EAAN,IAEA,OAAOhJ,GAAOgJ,EAAD,GAAc9S,KAA3B,cAEF4lD,aAtDQ,WAuDN,OAAK5lD,KAAD,KAAaA,KAAjB,YAA0C,EAEnCA,KAAK8iD,SAAS+C,YAArB,MAEFC,kBA3DQ,WA4DN,OAAK9lD,KAAL,IAEOA,KAAK8iD,SAAS+C,YAArB,IAFsB,GAIxBE,gBAhEQ,WAiEN,GAAK/lD,KAAL,gBAEA,OAAOA,KAAP,aAEFgmD,uBArEQ,WAsEN,IAAIv3C,EAAS,8CAAb,MAEA,OADIzO,KAAJ,aAAqByO,GAAU+0B,SAASxjC,KAAnB,kBACrB,GAEFimD,cA1EQ,WA2EN,OAAKjmD,KAAD,KAAaA,KAAjB,aAA2C,EAEpCA,KAAK8iD,SAAS+C,YAArB,OAEFlB,wBA/EQ,WAgFN,OAAI3kD,KAAJ,gBAAiC4M,OAAO5M,KAAd,iBAEnBA,KAAKgmD,wBAA0BhmD,KAAKqI,MAAQ,GAAnD,KAEF69C,kBApFQ,WAqFN,IACGlmD,KAAD,WACCA,KAAKmlD,iBAAL,IAAwBnlD,KAAKokD,eAAuBpkD,KAFvD,SAGE,OAAO,EAET,GAAIA,KAAJ,SAAmB,OAAO,EAE1B,IAAMulD,EAAkBvlD,KAAKulD,gBACzBvlD,KADoB,eAEpBA,KAFJ,sBAIA,OAAOA,KAAKkiD,OAASqD,GAArB,GAEFY,WAlGQ,WAmGN,OAAInmD,KAAKmlD,iBAAmBnlD,KAA5B,WACSA,KAAKokD,cAAgBpkD,KAA5B,wBAGEA,KAAJ,gBACgC,IAAvBA,KAAKokD,eACVpkD,KAAKkmD,kBADP,IAKClmD,KAAD,YACAA,KAFK,kBAAP,IAGKA,KAAKkmD,mBAEZvD,YAjHQ,WAkHN,OAAK3iD,KAAL,iBAIOA,KAAKokD,cAAZ,EAHS,oCAAP,OAKJvB,YAxHQ,WAyHN,OACE,2CACA7iD,KAFF,gBAKFmW,OA9HQ,WA+HN,wCACK,+BADE,OAAP,IAEE7H,SAAU,eAActO,KAAD,iBAFlB,OAGLomD,UAAW,eAAcpmD,KAHpB,mBAILg8C,UAAW,cAAF,OAAgB,eAAch8C,KAJlC,mBAII,KACTyM,KAAM,eAAczM,KALf,cAML0M,MAAO,eAAc1M,KAAD,mBAK1B4f,MAAO,CACL8kC,UADK,WAELwB,kBAFK,WAUAlmD,KAAD,YACEA,KAAD,aAAsBA,KAFzB,eAKAA,KAAA,cAEFslD,eAhBK,SAgBS,GACZtlD,KAAA,UAAiB+H,GAAjB,IAAwB/H,KAAKokD,gBAIjChhB,QA9L+B,WA+LzBpjC,KAAJ,iBAAyBA,KAAKskD,UAAW,IAG3Cl3C,QAAS,CACP61C,cADO,WAEL,IAAM16C,EAAS,qCAAf,MAMA,OAJAA,EAAA,KAAcvI,KAAK6xB,GAAGtpB,EAAA,MAAR,GAA2BA,EAA3B,IAAwC,CACpDiG,MAAO,CAAE63C,QAASrmD,KAAK+lD,mBAGzB,GAEF9B,kBAVO,WAWL,OAAOjkD,KAAKslD,eAAL,EAEHtlD,KAAK0iD,eAAiB1iD,KAF1B,mBAIF6kD,aAfO,WAgBD7kD,KAAJ,eACEA,KAAA,SAAgBA,KAAKokD,cAAgBpkD,KAArC,yBAIEA,KAAJ,eACEA,KAAA,SAAgBA,KAAKukD,eACnBvkD,KAAKokD,cAAgBpkD,KADvB,yBAIEA,KAAKqkD,iBAAmBrkD,KAA5B,0BAEAA,KAAA,YAAmBA,KAAnB,kBAIJuI,OAlO+B,SAkOzB,GACJ,IAAMA,EAAS,2BAAf,GAaA,OAXAA,EAAA,KAAcA,EAAA,MAAd,GAEIvI,KAAJ,YACEuI,EAAA,gBAAyBA,EAAA,iBAAzB,GACAA,EAAA,qBAA4B,CAC1BykC,IAAKhtC,KADqB,aAE1ByC,KAF0B,SAG1BkG,MAAO3I,KAAK4kD,YAIhB,M,uBCvRJ,IAAI90C,EAAS,EAAQ,QAErBvR,EAAOC,QAAUsR,G,uBCFjB,IAAI1J,EAAQ,EAAQ,QAChBsJ,EAAU,EAAQ,QAElBtF,EAAQ,GAAGA,MAGf7L,EAAOC,QAAU4H,GAAM,WAGrB,OAAQ3E,OAAO,KAAK6kD,qBAAqB,MACtC,SAAU1kD,GACb,MAAsB,UAAf8N,EAAQ9N,GAAkBwI,EAAMrL,KAAK6C,EAAI,IAAMH,OAAOG,IAC3DH,Q,uBCZJ,IAAIrD,EAAkB,EAAQ,QAC1Bgc,EAAS,EAAQ,QACjBpD,EAAuB,EAAQ,QAE/BuvC,EAAcnoD,EAAgB,eAC9BooD,EAAiBtkD,MAAMhB,eAIQpC,GAA/B0nD,EAAeD,IACjBvvC,EAAqB3V,EAAEmlD,EAAgBD,EAAa,CAClDrvC,cAAc,EACdvO,MAAOyR,EAAO,QAKlB7b,EAAOC,QAAU,SAAUwP,GACzBw4C,EAAeD,GAAav4C,IAAO,I,uBClBrC,IAAI8B,EAAS,EAAQ,QAErBvR,EAAOC,QAAU,SAAUQ,EAAGC,GAC5B,IAAIqqB,EAAUxZ,EAAOwZ,QACjBA,GAAWA,EAAQznB,QACA,IAArBzC,UAAUP,OAAeyqB,EAAQznB,MAAM7C,GAAKsqB,EAAQznB,MAAM7C,EAAGC,M,uBCLjE,IAAIkB,EAAW,EAAQ,QACnBuP,EAAU,EAAQ,QAClBtR,EAAkB,EAAQ,QAE1BqoD,EAAQroD,EAAgB,SAI5BG,EAAOC,QAAU,SAAUoD,GACzB,IAAIyH,EACJ,OAAOlJ,EAASyB,UAAmC9C,KAA1BuK,EAAWzH,EAAG6kD,MAA0Bp9C,EAA0B,UAAfqG,EAAQ9N,M,oCCTtF,IAAIwH,EAAgC,EAAQ,QACxCE,EAAW,EAAQ,QACnB9J,EAAW,EAAQ,QACnBuJ,EAAyB,EAAQ,QACjCS,EAAqB,EAAQ,QAC7Bk9C,EAAa,EAAQ,QAGzBt9C,EAA8B,QAAS,GAAG,SAAUq9C,EAAOE,EAAaz8C,GACtE,MAAO,CAGL,SAAeqB,GACb,IAAIxL,EAAIgJ,EAAuB/I,MAC3B4mD,OAAoB9nD,GAAVyM,OAAsBzM,EAAYyM,EAAOk7C,GACvD,YAAmB3nD,IAAZ8nD,EAAwBA,EAAQ7nD,KAAKwM,EAAQxL,GAAK,IAAIoL,OAAOI,GAAQk7C,GAAOhoD,OAAOsB,KAI5F,SAAUwL,GACR,IAAIC,EAAMtB,EAAgBy8C,EAAap7C,EAAQvL,MAC/C,GAAIwL,EAAIC,KAAM,OAAOD,EAAI7C,MAEzB,IAAI+C,EAAKpC,EAASiC,GACdI,EAAIlN,OAAOuB,MAEf,IAAK0L,EAAGoE,OAAQ,OAAO42C,EAAWh7C,EAAIC,GAEtC,IAAIk7C,EAAcn7C,EAAGX,QACrBW,EAAGjB,UAAY,EACf,IAEIxB,EAFA/I,EAAI,GACJqC,EAAI,EAER,MAAwC,QAAhC0G,EAASy9C,EAAWh7C,EAAIC,IAAc,CAC5C,IAAIm7C,EAAWroD,OAAOwK,EAAO,IAC7B/I,EAAEqC,GAAKukD,EACU,KAAbA,IAAiBp7C,EAAGjB,UAAYjB,EAAmBmC,EAAGnM,EAASkM,EAAGjB,WAAYo8C,IAClFtkD,IAEF,OAAa,IAANA,EAAU,KAAOrC,Q,oCCtC9B,IAAI6mD,EAAc,EAAQ,QAS1BxoD,EAAOC,QAAU,SAAgBgG,EAAS8zB,EAAQv0B,GAChD,IAAI4R,EAAiB5R,EAASC,OAAO2R,eAEhC5R,EAAS6R,QAAWD,IAAkBA,EAAe5R,EAAS6R,QAGjE0iB,EAAOyuB,EACL,mCAAqChjD,EAAS6R,OAC9C7R,EAASC,OACT,KACAD,EAASD,QACTC,IAPFS,EAAQT,K,4CCfZ,IAAIuF,EAAW,EAAQ,QACnB5K,EAAY,EAAQ,QACpBN,EAAkB,EAAQ,QAE1BqT,EAAUrT,EAAgB,WAI9BG,EAAOC,QAAU,SAAUuB,EAAGinD,GAC5B,IACIr7C,EADApL,EAAI+I,EAASvJ,GAAGyC,YAEpB,YAAa1D,IAANyB,QAAiDzB,IAA7B6M,EAAIrC,EAAS/I,GAAGkR,IAAyBu1C,EAAqBtoD,EAAUiN,K,qBCVrG,IAAI6F,EAAa,EAAQ,QACrBpL,EAAQ,EAAQ,QAGpB7H,EAAOC,UAAYiD,OAAOwlD,wBAA0B7gD,GAAM,WACxD,OAAQ3H,OAAO+hB,YAGZA,OAAO5M,MAAQpC,GAAcA,EAAa,O,oCCR/C,IAAInS,EAAI,EAAQ,QACZ6nD,EAAQ,EAAQ,QAA4BzW,KAC5C0W,EAAyB,EAAQ,QAIrC9nD,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,OAAQy2C,EAAuB,SAAW,CAC3E1W,KAAM,WACJ,OAAOyW,EAAMlnD,U,uBCTjB,IAAIX,EAAI,EAAQ,QACZwR,EAAa,EAAQ,QACrBnS,EAAY,EAAQ,QACpB4K,EAAW,EAAQ,QACnBnJ,EAAW,EAAQ,QACnBia,EAAS,EAAQ,QACjBtZ,EAAO,EAAQ,QACfsF,EAAQ,EAAQ,QAEhBghD,EAAkBv2C,EAAW,UAAW,aAMxCw2C,EAAiBjhD,GAAM,WACzB,SAASkhD,KACT,QAASF,GAAgB,cAA6B,GAAIE,aAAcA,MAEtEC,GAAYnhD,GAAM,WACpBghD,GAAgB,kBAEdh0C,EAASi0C,GAAkBE,EAE/BloD,EAAE,CAAEM,OAAQ,UAAW2D,MAAM,EAAMoN,OAAQ0C,EAAQQ,KAAMR,GAAU,CACjE9S,UAAW,SAAmBknD,EAAQ/mD,GACpC/B,EAAU8oD,GACVl+C,EAAS7I,GACT,IAAIgnD,EAAYroD,UAAUP,OAAS,EAAI2oD,EAAS9oD,EAAUU,UAAU,IACpE,GAAImoD,IAAaF,EAAgB,OAAOD,EAAgBI,EAAQ/mD,EAAMgnD,GACtE,GAAID,GAAUC,EAAW,CAEvB,OAAQhnD,EAAK5B,QACX,KAAK,EAAG,OAAO,IAAI2oD,EACnB,KAAK,EAAG,OAAO,IAAIA,EAAO/mD,EAAK,IAC/B,KAAK,EAAG,OAAO,IAAI+mD,EAAO/mD,EAAK,GAAIA,EAAK,IACxC,KAAK,EAAG,OAAO,IAAI+mD,EAAO/mD,EAAK,GAAIA,EAAK,GAAIA,EAAK,IACjD,KAAK,EAAG,OAAO,IAAI+mD,EAAO/mD,EAAK,GAAIA,EAAK,GAAIA,EAAK,GAAIA,EAAK,IAG5D,IAAIinD,EAAQ,CAAC,MAEb,OADAA,EAAM5iD,KAAK3F,MAAMuoD,EAAOjnD,GACjB,IAAKK,EAAK3B,MAAMqoD,EAAQE,IAGjC,IAAI9nD,EAAQ6nD,EAAUvmD,UAClBymD,EAAWvtC,EAAOja,EAASP,GAASA,EAAQ6B,OAAOP,WACnD+H,EAASrI,SAASzB,MAAMJ,KAAKyoD,EAAQG,EAAUlnD,GACnD,OAAON,EAAS8I,GAAUA,EAAS0+C,M,gDChDvC,IAAIxmD,EAAkB,EAAQ,QAC1B3B,EAAW,EAAQ,QACnBooD,EAAkB,EAAQ,QAG1BC,EAAe,SAAUC,GAC3B,OAAO,SAAUC,EAAOjtB,EAAIktB,GAC1B,IAGIr/C,EAHA5I,EAAIoB,EAAgB4mD,GACpBlpD,EAASW,EAASO,EAAElB,QACpBwM,EAAQu8C,EAAgBI,EAAWnpD,GAIvC,GAAIipD,GAAehtB,GAAMA,GAAI,MAAOj8B,EAASwM,EAG3C,GAFA1C,EAAQ5I,EAAEsL,KAEN1C,GAASA,EAAO,OAAO,OAEtB,KAAM9J,EAASwM,EAAOA,IAC3B,IAAKy8C,GAAez8C,KAAStL,IAAMA,EAAEsL,KAAWyvB,EAAI,OAAOgtB,GAAez8C,GAAS,EACnF,OAAQy8C,IAAgB,IAI9BvpD,EAAOC,QAAU,CAGf8X,SAAUuxC,GAAa,GAGvBrxC,QAASqxC,GAAa,K,oCC7BxB,IAAIxoD,EAAI,EAAQ,QACZ4oD,EAAU,EAAQ,QAAgCtlB,OAClDulB,EAA+B,EAAQ,QAEvCC,EAAsBD,EAA6B,UAKvD7oD,EAAE,CAAEM,OAAQ,QAASC,OAAO,EAAM8Q,QAASy3C,GAAuB,CAChExlB,OAAQ,SAAgBpyB,GACtB,OAAO03C,EAAQjoD,KAAMuQ,EAAYnR,UAAUP,OAAS,EAAIO,UAAU,QAAKN,O,oCCX3E,IAAIgC,EAAO,EAAQ,QACfvB,EAAW,EAAQ,QACnB6oD,EAA+B,EAAQ,QACvCv2C,EAAwB,EAAQ,QAChCrS,EAAW,EAAQ,QACnB6oD,EAAiB,EAAQ,QACzBv2C,EAAoB,EAAQ,QAIhCvT,EAAOC,QAAU,SAAc8pD,GAC7B,IAOIzpD,EAAQoK,EAAQsJ,EAAMF,EAAUnB,EAAMvI,EAPtC5I,EAAIR,EAAS+oD,GACb/nD,EAAmB,mBAARP,KAAqBA,KAAOkC,MACvCqmD,EAAkBnpD,UAAUP,OAC5B2pD,EAAQD,EAAkB,EAAInpD,UAAU,QAAKN,EAC7C2pD,OAAoB3pD,IAAV0pD,EACVE,EAAiB52C,EAAkB/R,GACnCsL,EAAQ,EAIZ,GAFIo9C,IAASD,EAAQ1nD,EAAK0nD,EAAOD,EAAkB,EAAInpD,UAAU,QAAKN,EAAW,SAE3DA,GAAlB4pD,GAAiCnoD,GAAK2B,OAAS2P,EAAsB62C,GAWvE,IAFA7pD,EAASW,EAASO,EAAElB,QACpBoK,EAAS,IAAI1I,EAAE1B,GACTA,EAASwM,EAAOA,IACpB1C,EAAQ8/C,EAAUD,EAAMzoD,EAAEsL,GAAQA,GAAStL,EAAEsL,GAC7Cg9C,EAAep/C,EAAQoC,EAAO1C,QAThC,IAHA0J,EAAWq2C,EAAe3pD,KAAKgB,GAC/BmR,EAAOmB,EAASnB,KAChBjI,EAAS,IAAI1I,IACLgS,EAAOrB,EAAKnS,KAAKsT,IAAW5G,KAAMJ,IACxC1C,EAAQ8/C,EAAUL,EAA6B/1C,EAAUm2C,EAAO,CAACj2C,EAAK5J,MAAO0C,IAAQ,GAAQkH,EAAK5J,MAClG0/C,EAAep/C,EAAQoC,EAAO1C,GAWlC,OADAM,EAAOpK,OAASwM,EACTpC,I,oCCtCT,IAAI0/C,EAAa,EAAQ,QACrBC,EAAmB,EAAQ,QAI/BrqD,EAAOC,QAAUmqD,EAAW,OAAO,SAAUt1B,GAC3C,OAAO,WAAiB,OAAOA,EAAKrzB,KAAMZ,UAAUP,OAASO,UAAU,QAAKN,MAC3E8pD,I,uBCRH,IAAInpD,EAAY,EAAQ,QAEpBqK,EAAM3E,KAAK2E,IAIfvL,EAAOC,QAAU,SAAUqqD,GACzB,OAAOA,EAAW,EAAI/+C,EAAIrK,EAAUopD,GAAW,kBAAoB,I,qBCPrE,IAAItpD,EAAW,EAAQ,QAEnBkb,EAAiB,GAAGA,eAExBlc,EAAOC,QAAU,SAAgBoD,EAAIoM,GACnC,OAAOyM,EAAe1b,KAAKQ,EAASqC,GAAKoM,K,kCCH3C,IAAIxK,EAAQ,EAAQ,QAChBslD,EAAgB,EAAQ,QACxBC,EAAW,EAAQ,QACnBxlD,EAAW,EAAQ,QACnBylD,EAAgB,EAAQ,QACxBC,EAAc,EAAQ,QAK1B,SAASC,EAA6BllD,GAChCA,EAAOmlD,aACTnlD,EAAOmlD,YAAYC,mBAUvB7qD,EAAOC,QAAU,SAAyBwF,GACxCklD,EAA6BllD,GAGzBA,EAAOqlD,UAAYL,EAAchlD,EAAOE,OAC1CF,EAAOE,IAAM+kD,EAAYjlD,EAAOqlD,QAASrlD,EAAOE,MAIlDF,EAAOmQ,QAAUnQ,EAAOmQ,SAAW,GAGnCnQ,EAAOiB,KAAO6jD,EACZ9kD,EAAOiB,KACPjB,EAAOmQ,QACPnQ,EAAOyQ,kBAITzQ,EAAOmQ,QAAU3Q,EAAMS,MACrBD,EAAOmQ,QAAQ0B,QAAU,GACzB7R,EAAOmQ,QAAQnQ,EAAOG,SAAW,GACjCH,EAAOmQ,SAAW,IAGpB3Q,EAAMiB,QACJ,CAAC,SAAU,MAAO,OAAQ,OAAQ,MAAO,QAAS,WAClD,SAA2BN,UAClBH,EAAOmQ,QAAQhQ,MAI1B,IAAImQ,EAAUtQ,EAAOsQ,SAAW/Q,EAAS+Q,QAEzC,OAAOA,EAAQtQ,GAAQe,MAAK,SAA6BhB,GAUvD,OATAmlD,EAA6BllD,GAG7BD,EAASkB,KAAO6jD,EACd/kD,EAASkB,KACTlB,EAASoQ,QACTnQ,EAAOqR,mBAGFtR,KACN,SAA4Bw0B,GAc7B,OAbKwwB,EAASxwB,KACZ2wB,EAA6BllD,GAGzBu0B,GAAUA,EAAOx0B,WACnBw0B,EAAOx0B,SAASkB,KAAO6jD,EACrBvwB,EAAOx0B,SAASkB,KAChBszB,EAAOx0B,SAASoQ,QAChBnQ,EAAOqR,qBAKN9Q,QAAQ+zB,OAAOC,Q,kCClF1B,IAAInvB,EAAgC,EAAQ,QACxCE,EAAW,EAAQ,QACnB9J,EAAW,EAAQ,QACnBC,EAAY,EAAQ,QACpBsJ,EAAyB,EAAQ,QACjCS,EAAqB,EAAQ,QAC7B8/C,EAAkB,EAAQ,QAC1B5C,EAAa,EAAQ,QAErB5zC,EAAM3N,KAAK2N,IACXhJ,EAAM3E,KAAK2E,IAEXy/C,EAAgB,SAAU3nD,GAC5B,YAAc9C,IAAP8C,EAAmBA,EAAKnD,OAAOmD,IAIxCwH,EAA8B,UAAW,GAAG,SAAUogD,EAASC,EAAev/C,EAAiBquB,GAC7F,IAAImxB,EAA+CnxB,EAAOmxB,6CACtDC,EAAmBpxB,EAAOoxB,iBAC1BC,EAAoBF,EAA+C,IAAM,KAE7E,MAAO,CAGL,SAAiBG,EAAaC,GAC5B,IAAI/pD,EAAIgJ,EAAuB/I,MAC3B+pD,OAA0BjrD,GAAf+qD,OAA2B/qD,EAAY+qD,EAAYL,GAClE,YAAoB1qD,IAAbirD,EACHA,EAAShrD,KAAK8qD,EAAa9pD,EAAG+pD,GAC9BL,EAAc1qD,KAAKN,OAAOsB,GAAI8pD,EAAaC,IAIjD,SAAUv+C,EAAQu+C,GAChB,IACIJ,GAAgDC,GACzB,kBAAjBG,IAA0E,IAA7CA,EAAatzC,QAAQozC,GAC1D,CACA,IAAIp+C,EAAMtB,EAAgBu/C,EAAel+C,EAAQvL,KAAM8pD,GACvD,GAAIt+C,EAAIC,KAAM,OAAOD,EAAI7C,MAG3B,IAAI+C,EAAKpC,EAASiC,GACdI,EAAIlN,OAAOuB,MAEXgqD,EAA4C,oBAAjBF,EAC1BE,IAAmBF,EAAerrD,OAAOqrD,IAE9C,IAAIh6C,EAASpE,EAAGoE,OAChB,GAAIA,EAAQ,CACV,IAAI+2C,EAAcn7C,EAAGX,QACrBW,EAAGjB,UAAY,EAEjB,IAAIw/C,EAAU,GACd,MAAO,EAAM,CACX,IAAIhhD,EAASy9C,EAAWh7C,EAAIC,GAC5B,GAAe,OAAX1C,EAAiB,MAGrB,GADAghD,EAAQnlD,KAAKmE,IACR6G,EAAQ,MAEb,IAAIg3C,EAAWroD,OAAOwK,EAAO,IACZ,KAAb69C,IAAiBp7C,EAAGjB,UAAYjB,EAAmBmC,EAAGnM,EAASkM,EAAGjB,WAAYo8C,IAKpF,IAFA,IAAIqD,EAAoB,GACpBC,EAAqB,EAChBxpD,EAAI,EAAGA,EAAIspD,EAAQprD,OAAQ8B,IAAK,CACvCsI,EAASghD,EAAQtpD,GAUjB,IARA,IAAI4E,EAAU9G,OAAOwK,EAAO,IACxBxD,EAAWqN,EAAIhJ,EAAIrK,EAAUwJ,EAAOoC,OAAQM,EAAE9M,QAAS,GACvD6G,EAAW,GAMNo2B,EAAI,EAAGA,EAAI7yB,EAAOpK,OAAQi9B,IAAKp2B,EAASZ,KAAKykD,EAActgD,EAAO6yB,KAC3E,IAAIn2B,EAAgBsD,EAAOmhD,OAC3B,GAAIJ,EAAmB,CACrB,IAAIK,EAAe,CAAC9kD,GAAStE,OAAOyE,EAAUD,EAAUkG,QAClC7M,IAAlB6G,GAA6B0kD,EAAavlD,KAAKa,GACnD,IAAIC,EAAcnH,OAAOqrD,EAAa3qD,WAAML,EAAWurD,SAEvDzkD,EAAc0jD,EAAgB/jD,EAASoG,EAAGlG,EAAUC,EAAUC,EAAemkD,GAE3ErkD,GAAY0kD,IACdD,GAAqBv+C,EAAEvL,MAAM+pD,EAAoB1kD,GAAYG,EAC7DukD,EAAqB1kD,EAAWF,EAAQ1G,QAG5C,OAAOqrD,EAAoBv+C,EAAEvL,MAAM+pD,S,kIC9F1B,SAASG,EAAQhxC,GAa9B,OATEgxC,EADoB,oBAAX9pC,QAAoD,kBAApBA,OAAOnO,SACtC,SAAiBiH,GACzB,cAAcA,GAGN,SAAiBA,GACzB,OAAOA,GAAyB,oBAAXkH,QAAyBlH,EAAI9W,cAAgBge,QAAUlH,IAAQkH,OAAOtf,UAAY,gBAAkBoY,GAItHgxC,EAAQhxC,K,gJCXjB,SAASoH,EAAQrP,EAAQk5C,GACvB,IAAI3tC,EAAOnb,OAAOmb,KAAKvL,GAEvB,GAAI5P,OAAOwlD,sBAAuB,CAChC,IAAIlhD,EAAUtE,OAAOwlD,sBAAsB51C,GAEvCk5C,IACFxkD,EAAUA,EAAQ48B,QAAO,SAAU6nB,GACjC,OAAO/oD,OAAOyB,yBAAyBmO,EAAQm5C,GAAKjsC,eAIxD3B,EAAK9X,KAAK3F,MAAMyd,EAAM7W,GAGxB,OAAO6W,EAGM,SAAS6tC,EAAe9qD,GACrC,IAAK,IAAIgB,EAAI,EAAGA,EAAIvB,UAAUP,OAAQ8B,IAAK,CACzC,IAAIyK,EAAyB,MAAhBhM,UAAUuB,GAAavB,UAAUuB,GAAK,GAE/CA,EAAI,EACN+f,EAAQjf,OAAO2J,IAAS,GAAM3G,SAAQ,SAAUuJ,GAC9C1H,eAAe3G,EAAQqO,EAAK5C,EAAO4C,OAE5BvM,OAAOipD,0BAChBjpD,OAAOwhB,iBAAiBtjB,EAAQ8B,OAAOipD,0BAA0Bt/C,IAEjEsV,EAAQjf,OAAO2J,IAAS3G,SAAQ,SAAUuJ,GACxCvM,OAAO6E,eAAe3G,EAAQqO,EAAKvM,OAAOyB,yBAAyBkI,EAAQ4C,OAKjF,OAAOrO,I,qBCrCT,IAAIk9C,EAAU,EAAQ,QAClB8N,EAAQ,EAAQ,SAEnBpsD,EAAOC,QAAU,SAAUwP,EAAKrF,GAC/B,OAAOgiD,EAAM38C,KAAS28C,EAAM38C,QAAiBlP,IAAV6J,EAAsBA,EAAQ,MAChE,WAAY,IAAI7D,KAAK,CACtBk/B,QAAS,SACT6V,KAAMgD,EAAU,OAAS,SACzB+N,UAAW,0C,uBCRb,IAAI/5C,EAAa,EAAQ,QACrBg6C,EAA4B,EAAQ,QACpCC,EAA8B,EAAQ,QACtCxhD,EAAW,EAAQ,QAGvB/K,EAAOC,QAAUqS,EAAW,UAAW,YAAc,SAAiBjP,GACpE,IAAIgb,EAAOiuC,EAA0BxpD,EAAEiI,EAAS1H,IAC5CqlD,EAAwB6D,EAA4BzpD,EACxD,OAAO4lD,EAAwBrqC,EAAK3b,OAAOgmD,EAAsBrlD,IAAOgb,I,mBCR1Ere,EAAOC,QAAU,iD,uBCDjB,IAAIuK,EAAyB,EAAQ,QACjCgiD,EAAc,EAAQ,QAEtBC,EAAa,IAAMD,EAAc,IACjCE,EAAQ9/C,OAAO,IAAM6/C,EAAaA,EAAa,KAC/CE,EAAQ//C,OAAO6/C,EAAaA,EAAa,MAGzCnD,EAAe,SAAUsD,GAC3B,OAAO,SAAUpD,GACf,IAAIx9C,EAAS9L,OAAOsK,EAAuBg/C,IAG3C,OAFW,EAAPoD,IAAU5gD,EAASA,EAAOnF,QAAQ6lD,EAAO,KAClC,EAAPE,IAAU5gD,EAASA,EAAOnF,QAAQ8lD,EAAO,KACtC3gD,IAIXhM,EAAOC,QAAU,CAGfmd,MAAOksC,EAAa,GAGpB7c,IAAK6c,EAAa,GAGlBpX,KAAMoX,EAAa,K,oCC1BrB,kDAKc,aAA2C,2BAA3C,EAA2C,yBAA3C,EAA2C,gBACvD,OAAO,cAAW,CAAEvgC,OAAQ7mB,M,uBCN9B,IAAI4I,EAAW,EAAQ,QAEvB9K,EAAOC,QAAU,SAAUoD,GACzB,GAAIyH,EAASzH,GACX,MAAMiO,UAAU,iDAChB,OAAOjO,I,qBCLXrD,EAAOC,QAAU,SAAU4sD,EAAQziD,GACjC,MAAO,CACL4V,aAAuB,EAAT6sC,GACdl0C,eAAyB,EAATk0C,GAChB5sC,WAAqB,EAAT4sC,GACZziD,MAAOA,K,gDCLX,IAAI+G,EAAU,EAAQ,QAClBI,EAAS,EAAQ,QAErBvR,EAAOC,QAAqC,WAA3BkR,EAAQI,EAAO0E,U,mBCHhCjW,EAAOC,QAA2B,iBAAVgD,Q,oCCCxB,IAAImB,EAAc,EAAQ,QACtByD,EAAQ,EAAQ,QAChBu5C,EAAa,EAAQ,QACrBmL,EAA8B,EAAQ,QACtCloD,EAA6B,EAAQ,QACrCrD,EAAW,EAAQ,QACnB8rD,EAAgB,EAAQ,QAGxBC,EAAU7pD,OAAO8pD,OAEjBjlD,EAAiB7E,OAAO6E,eAI5B/H,EAAOC,SAAW8sD,GAAWllD,GAAM,WAEjC,GAAIzD,GAQiB,IARF2oD,EAAQ,CAAErsD,EAAG,GAAKqsD,EAAQhlD,EAAe,GAAI,IAAK,CACnEiY,YAAY,EACZhY,IAAK,WACHD,EAAetG,KAAM,IAAK,CACxB2I,MAAO,EACP4V,YAAY,OAGd,CAAEtf,EAAG,KAAMA,EAAS,OAAO,EAE/B,IAAIiB,EAAI,GACJsrD,EAAI,GAEJv6B,EAASzQ,SACTirC,EAAW,uBAGf,OAFAvrD,EAAE+wB,GAAU,EACZw6B,EAASrhD,MAAM,IAAI3F,SAAQ,SAAUinD,GAAOF,EAAEE,GAAOA,KACpB,GAA1BJ,EAAQ,GAAIprD,GAAG+wB,IAAgB0uB,EAAW2L,EAAQ,GAAIE,IAAI3qD,KAAK,KAAO4qD,KAC1E,SAAgB9rD,EAAQyL,GAC3B,IAAIugD,EAAIpsD,EAASI,GACb4oD,EAAkBnpD,UAAUP,OAC5BwM,EAAQ,EACR47C,EAAwB6D,EAA4BzpD,EACpDilD,EAAuB1jD,EAA2BvB,EACtD,MAAOknD,EAAkBl9C,EAAO,CAC9B,IAII2C,EAJArC,EAAI0/C,EAAcjsD,UAAUiM,MAC5BuR,EAAOqqC,EAAwBtH,EAAWh0C,GAAG1K,OAAOgmD,EAAsBt7C,IAAMg0C,EAAWh0C,GAC3F9M,EAAS+d,EAAK/d,OACdi9B,EAAI,EAER,MAAOj9B,EAASi9B,EACd9tB,EAAM4O,EAAKkf,KACNn5B,IAAe2jD,EAAqBvnD,KAAK4M,EAAGqC,KAAM29C,EAAE39C,GAAOrC,EAAEqC,IAEpE,OAAO29C,GACPL,G,8NC9CE7kD,EAAc,CAAC,KAAM,KAAM,KAAjC,MAEMmlD,EAAmB,WACvB,OAAOnlD,EAAA,QAAmB,cAKxB,OAJAG,EAAA,GAAa,CACXK,KAAM,CAACgG,QAASxO,OADL,QAEXyI,SAAS,GAEX,IALF,IADuB,GAUnB2kD,EAAe,WACnB,OAAOplD,EAAA,QAAmB,cAKxB,OAJAG,EAAM,SAAW,eAAjB,IAAoC,CAClCK,KAAM,CAACxI,OAD2B,QAElCyI,QAAS,MAEX,IALF,IADmB,GAUf4kD,EAAc,WAClB,OAAOrlD,EAAA,QAAmB,cAKxB,OAJAG,EAAM,QAAU,eAAhB,IAAmC,CACjCK,KAAM,CAACxI,OAD0B,QAEjCyI,QAAS,MAEX,IALF,IADkB,GAUdM,EAAU,CACdukD,IAAKtqD,OAAA,KADS,GAEduqD,OAAQvqD,OAAA,KAFM,GAGdwqD,MAAOxqD,OAAA,SAGT,SAASoG,EAAT,OACE,IAAIC,EAAJ,EACA,GAAI,MAAAC,IAAJ,IAAmBA,EAAnB,CAGA,KAAU,CACR,IAAMC,EAAaC,EAAA,UAAnB,IACAH,GAAa,IAAJ,OAAT,GAKF,MAAI,QAAAb,GAAmB,KAAAc,IAAvB,IAAqCA,GAKrCD,GAAa,IAAJ,OAAT,GACOA,EAAP,eAJSA,EAAP,eAOJ,IAAMI,EAAQ,IAAd,IAEe,qBAAW,CACxBzF,KADwB,QAExB0F,YAFwB,EAGxBvB,MAAO,6DACLslD,KAAM,CACJjlD,KAAM,CAACgG,QAASxO,OADZ,QAEJyI,SAAS,IAHN,GAAF,IAMH8kD,OAAQ,CACN/kD,KAAM,CAACxI,OADD,QAENyI,QAAS,OARN,GAAF,IAWH+kD,MAAO,CACLhlD,KAAM,CAACxI,OADF,QAELyI,QAAS,OAbN,GAAF,IAgBHilD,UAAW,CACTllD,KADS,OAETC,QAFS,KAGTC,UAAY,SAAA3B,GAAD,MAAc,CAAC,OAAQ,QAAS,MAAO,SAAU,WAAY,WAAW8Q,SAAS9Q,KAE9F4C,IAAK,CACHnB,KADG,OAEHC,QAAS,SAGbqB,OA7BwB,SA6BlB,EA7BkB,GA6BoB,IAAjC,EAAiC,EAAjC,QAAiC,EAAjC,OAAiC,EAAjC,SAELE,GAFsC,EAARwP,OAElC,IACA,IAAK,IAAL,OACExP,GAAYhK,OAAQmI,EAApB,IAEF,IAAI8B,EAAYR,EAAA,IAAhB,GA4BA,OA1BA,GAAgB,iBAGd,EACA,SAHAQ,EADc,GAId,EACElB,EAAA,YAAsB,SAAAS,GACpB,IAAMU,EAAoC/B,EAA1C,GACMkB,EAAYD,EAAgBZ,EAAMgB,EAAxC,GACA,GAAeS,EAAA,WAInB,IAAM0jD,EAAgB1jD,EAAA,MAAe,SAAAZ,GAAS,OAAIA,EAAA,WAAlD,WAEAY,EAAA,SAEEqjD,KAAMK,IAAkBxlD,EAFX,MAAf,+BAGUA,EAAR,MAAuBA,EAHV,MAAf,kCAIaA,EAAX,QAA4BA,EAJf,QAAf,iCAKYA,EAAV,OAA0BA,EALb,OAAf,sCAMiBA,EAAf,WAAmCA,EAAMulD,WAN3C,IASAjkD,EAAA,SAvBc,GA0BTU,EAAEhC,EAAD,IAAY,eAAU3B,EAAM,CAAE6D,MAAOJ,IAA7C,O,mBC/HJnK,EAAOC,QAAU,SAA4BgR,EAAWsxB,GACtD,IAAI1uB,EAAuC,oBAAtB5C,EAAUhR,QAC3BgR,EAAUhR,QAAQqiC,cAClBrxB,EAAU4C,QAQd,IAAK,IAAIzR,IANwB,oBAAtB6O,EAAUhR,UACnB4T,EAAQ0uB,WAAatxB,EAAUhR,QAAQ4T,QAAQ0uB,YAGjD1uB,EAAQ0uB,WAAa1uB,EAAQ0uB,YAAc,GAE7BA,EACZ1uB,EAAQ0uB,WAAWngC,GAAKyR,EAAQ0uB,WAAWngC,IAAMmgC,EAAWngC,K,qBChBhE,IAAIlB,EAAY,EAAQ,QACpBsJ,EAAyB,EAAQ,QAGjC8+C,EAAe,SAAUwE,GAC3B,OAAO,SAAUtE,EAAO1M,GACtB,IAGIiR,EAAOC,EAHP5gD,EAAIlN,OAAOsK,EAAuBg/C,IAClCtiD,EAAWhG,EAAU47C,GACrB1uC,EAAOhB,EAAE9M,OAEb,OAAI4G,EAAW,GAAKA,GAAYkH,EAAa0/C,EAAoB,QAAKvtD,GACtEwtD,EAAQ3gD,EAAE2S,WAAW7Y,GACd6mD,EAAQ,OAAUA,EAAQ,OAAU7mD,EAAW,IAAMkH,IACtD4/C,EAAS5gD,EAAE2S,WAAW7Y,EAAW,IAAM,OAAU8mD,EAAS,MAC1DF,EAAoB1gD,EAAExF,OAAOV,GAAY6mD,EACzCD,EAAoB1gD,EAAEvL,MAAMqF,EAAUA,EAAW,GAA+B8mD,EAAS,OAAlCD,EAAQ,OAAU,IAA0B,SAI7G/tD,EAAOC,QAAU,CAGfguD,OAAQ3E,GAAa,GAGrB1hD,OAAQ0hD,GAAa,K,kCCxBvB,IAAIvhD,EAAiB,EAAQ,QAAuCjF,EAChE+Y,EAAS,EAAQ,QACjBqyC,EAAc,EAAQ,QACtB3rD,EAAO,EAAQ,QACf4rD,EAAa,EAAQ,QACrBC,EAAU,EAAQ,QAClBxL,EAAiB,EAAQ,QACzByL,EAAa,EAAQ,QACrBjqD,EAAc,EAAQ,QACtBkqD,EAAU,EAAQ,QAAkCA,QACpD3L,EAAsB,EAAQ,QAE9BG,EAAmBH,EAAoBtgC,IACvCksC,EAAyB5L,EAAoBK,UAEjDhjD,EAAOC,QAAU,CACfuuD,eAAgB,SAAUC,EAAS/1C,EAAkBg2C,EAAQC,GAC3D,IAAI3sD,EAAIysD,GAAQ,SAAUpuD,EAAMsT,GAC9Bw6C,EAAW9tD,EAAM2B,EAAG0W,GACpBoqC,EAAiBziD,EAAM,CACrBqI,KAAMgQ,EACN5L,MAAO+O,EAAO,MACdkyC,WAAOxtD,EACP+tB,UAAM/tB,EACN6N,KAAM,IAEHhK,IAAa/D,EAAK+N,KAAO,QACd7N,GAAZoT,GAAuBy6C,EAAQz6C,EAAUtT,EAAKsuD,GAAQ,CAAEtuD,KAAMA,EAAM4T,WAAYy6C,OAGlF3L,EAAmBwL,EAAuB71C,GAE1Ck2C,EAAS,SAAUvuD,EAAMoP,EAAKrF,GAChC,IAEIykD,EAAU/hD,EAFVq2C,EAAQJ,EAAiB1iD,GACzByuD,EAAQC,EAAS1uD,EAAMoP,GAqBzB,OAlBEq/C,EACFA,EAAM1kD,MAAQA,GAGd+4C,EAAM70B,KAAOwgC,EAAQ,CACnBhiD,MAAOA,EAAQwhD,EAAQ7+C,GAAK,GAC5BA,IAAKA,EACLrF,MAAOA,EACPykD,SAAUA,EAAW1L,EAAM70B,KAC3B3b,UAAMpS,EACNq8C,SAAS,GAENuG,EAAM4K,QAAO5K,EAAM4K,MAAQe,GAC5BD,IAAUA,EAASl8C,KAAOm8C,GAC1B1qD,EAAa++C,EAAM/0C,OAClB/N,EAAK+N,OAEI,MAAVtB,IAAeq2C,EAAMr2C,MAAMA,GAASgiD,IACjCzuD,GAGP0uD,EAAW,SAAU1uD,EAAMoP,GAC7B,IAGIq/C,EAHA3L,EAAQJ,EAAiB1iD,GAEzByM,EAAQwhD,EAAQ7+C,GAEpB,GAAc,MAAV3C,EAAe,OAAOq2C,EAAMr2C,MAAMA,GAEtC,IAAKgiD,EAAQ3L,EAAM4K,MAAOe,EAAOA,EAAQA,EAAMn8C,KAC7C,GAAIm8C,EAAMr/C,KAAOA,EAAK,OAAOq/C,GAiFjC,OA7EAZ,EAAYlsD,EAAEW,UAAW,CAGvB2f,MAAO,WACL,IAAIjiB,EAAOoB,KACP0hD,EAAQJ,EAAiB1iD,GACzBqG,EAAOy8C,EAAMr2C,MACbgiD,EAAQ3L,EAAM4K,MAClB,MAAOe,EACLA,EAAMlS,SAAU,EACZkS,EAAMD,WAAUC,EAAMD,SAAWC,EAAMD,SAASl8C,UAAOpS,UACpDmG,EAAKooD,EAAMhiD,OAClBgiD,EAAQA,EAAMn8C,KAEhBwwC,EAAM4K,MAAQ5K,EAAM70B,UAAO/tB,EACvB6D,EAAa++C,EAAM/0C,KAAO,EACzB/N,EAAK+N,KAAO,GAInB,OAAU,SAAUqB,GAClB,IAAIpP,EAAOoB,KACP0hD,EAAQJ,EAAiB1iD,GACzByuD,EAAQC,EAAS1uD,EAAMoP,GAC3B,GAAIq/C,EAAO,CACT,IAAIn8C,EAAOm8C,EAAMn8C,KACb0yC,EAAOyJ,EAAMD,gBACV1L,EAAMr2C,MAAMgiD,EAAMhiD,OACzBgiD,EAAMlS,SAAU,EACZyI,IAAMA,EAAK1yC,KAAOA,GAClBA,IAAMA,EAAKk8C,SAAWxJ,GACtBlC,EAAM4K,OAASe,IAAO3L,EAAM4K,MAAQp7C,GACpCwwC,EAAM70B,MAAQwgC,IAAO3L,EAAM70B,KAAO+2B,GAClCjhD,EAAa++C,EAAM/0C,OAClB/N,EAAK+N,OACV,QAAS0gD,GAIb5oD,QAAS,SAAiB8L,GACxB,IAEI88C,EAFA3L,EAAQJ,EAAiBthD,MACzBgB,EAAgBF,EAAKyP,EAAYnR,UAAUP,OAAS,EAAIO,UAAU,QAAKN,EAAW,GAEtF,MAAOuuD,EAAQA,EAAQA,EAAMn8C,KAAOwwC,EAAM4K,MAAO,CAC/CtrD,EAAcqsD,EAAM1kD,MAAO0kD,EAAMr/C,IAAKhO,MAEtC,MAAOqtD,GAASA,EAAMlS,QAASkS,EAAQA,EAAMD,WAKjDrqD,IAAK,SAAaiL,GAChB,QAASs/C,EAASttD,KAAMgO,MAI5By+C,EAAYlsD,EAAEW,UAAW+rD,EAAS,CAEhC1mD,IAAK,SAAayH,GAChB,IAAIq/C,EAAQC,EAASttD,KAAMgO,GAC3B,OAAOq/C,GAASA,EAAM1kD,OAGxBiY,IAAK,SAAa5S,EAAKrF,GACrB,OAAOwkD,EAAOntD,KAAc,IAARgO,EAAY,EAAIA,EAAKrF,KAEzC,CAEFyP,IAAK,SAAazP,GAChB,OAAOwkD,EAAOntD,KAAM2I,EAAkB,IAAVA,EAAc,EAAIA,EAAOA,MAGrDhG,GAAa2D,EAAe/F,EAAEW,UAAW,OAAQ,CACnDqF,IAAK,WACH,OAAO+6C,EAAiBthD,MAAM2M,QAG3BpM,GAETgtD,UAAW,SAAUhtD,EAAG0W,EAAkBg2C,GACxC,IAAIO,EAAgBv2C,EAAmB,YACnCw2C,EAA6BX,EAAuB71C,GACpDy2C,EAA2BZ,EAAuBU,GAGtDrM,EAAe5gD,EAAG0W,GAAkB,SAAUuqC,EAAUmM,GACtDtM,EAAiBrhD,KAAM,CACrBiH,KAAMumD,EACN7tD,OAAQ6hD,EACRE,MAAO+L,EAA2BjM,GAClCmM,KAAMA,EACN9gC,UAAM/tB,OAEP,WACD,IAAI4iD,EAAQgM,EAAyB1tD,MACjC2tD,EAAOjM,EAAMiM,KACbN,EAAQ3L,EAAM70B,KAElB,MAAOwgC,GAASA,EAAMlS,QAASkS,EAAQA,EAAMD,SAE7C,OAAK1L,EAAM/hD,SAAY+hD,EAAM70B,KAAOwgC,EAAQA,EAAQA,EAAMn8C,KAAOwwC,EAAMA,MAAM4K,OAMjE,QAARqB,EAAuB,CAAEhlD,MAAO0kD,EAAMr/C,IAAKvC,MAAM,GACzC,UAARkiD,EAAyB,CAAEhlD,MAAO0kD,EAAM1kD,MAAO8C,MAAM,GAClD,CAAE9C,MAAO,CAAC0kD,EAAMr/C,IAAKq/C,EAAM1kD,OAAQ8C,MAAM,IAN9Ci2C,EAAM/hD,YAASb,EACR,CAAE6J,WAAO7J,EAAW2M,MAAM,MAMlCwhD,EAAS,UAAY,UAAWA,GAAQ,GAG3CL,EAAW31C,M,uBCvLf,IAAI9W,EAAW,EAAQ,QACnB2Z,EAAU,EAAQ,QAClB1b,EAAkB,EAAQ,QAE1BqT,EAAUrT,EAAgB,WAI9BG,EAAOC,QAAU,SAAUovD,EAAe/uD,GACxC,IAAI0B,EASF,OAREuZ,EAAQ8zC,KACVrtD,EAAIqtD,EAAcprD,YAEF,mBAALjC,GAAoBA,IAAM2B,QAAS4X,EAAQvZ,EAAEW,WAC/Cf,EAASI,KAChBA,EAAIA,EAAEkR,GACI,OAANlR,IAAYA,OAAIzB,IAH+CyB,OAAIzB,GAKlE,SAAWA,IAANyB,EAAkB2B,MAAQ3B,GAAc,IAAX1B,EAAe,EAAIA,K,uBClBhE,IAWI+hB,EAAKra,EAAKxD,EAXV8qD,EAAkB,EAAQ,QAC1B/9C,EAAS,EAAQ,QACjB3P,EAAW,EAAQ,QACnB6P,EAA8B,EAAQ,QACtC89C,EAAY,EAAQ,QACpBC,EAAS,EAAQ,QACjBC,EAAY,EAAQ,QACpBj6C,EAAa,EAAQ,QAErBk6C,EAA6B,6BAC7BC,EAAUp+C,EAAOo+C,QAGjBC,EAAU,SAAUvsD,GACtB,OAAOmB,EAAInB,GAAM2E,EAAI3E,GAAMgf,EAAIhf,EAAI,KAGjC2/C,EAAY,SAAU4J,GACxB,OAAO,SAAUvpD,GACf,IAAI8/C,EACJ,IAAKvhD,EAASyB,KAAQ8/C,EAAQn7C,EAAI3E,IAAKqF,OAASkkD,EAC9C,MAAMt7C,UAAU,0BAA4Bs7C,EAAO,aACnD,OAAOzJ,IAIb,GAAImM,GAAmBE,EAAOrM,MAAO,CACnC,IAAIiJ,EAAQoD,EAAOrM,QAAUqM,EAAOrM,MAAQ,IAAIwM,GAC5CE,EAAQzD,EAAMpkD,IACd8nD,EAAQ1D,EAAM5nD,IACdurD,EAAQ3D,EAAM/pC,IAClBA,EAAM,SAAUhf,EAAI2sD,GAClB,GAAIF,EAAMtvD,KAAK4rD,EAAO/oD,GAAK,MAAM,IAAIiO,UAAUo+C,GAG/C,OAFAM,EAASC,OAAS5sD,EAClB0sD,EAAMvvD,KAAK4rD,EAAO/oD,EAAI2sD,GACfA,GAEThoD,EAAM,SAAU3E,GACd,OAAOwsD,EAAMrvD,KAAK4rD,EAAO/oD,IAAO,IAElCmB,EAAM,SAAUnB,GACd,OAAOysD,EAAMtvD,KAAK4rD,EAAO/oD,QAEtB,CACL,IAAI6sD,EAAQT,EAAU,SACtBj6C,EAAW06C,IAAS,EACpB7tC,EAAM,SAAUhf,EAAI2sD,GAClB,GAAIT,EAAUlsD,EAAI6sD,GAAQ,MAAM,IAAI5+C,UAAUo+C,GAG9C,OAFAM,EAASC,OAAS5sD,EAClBoO,EAA4BpO,EAAI6sD,EAAOF,GAChCA,GAEThoD,EAAM,SAAU3E,GACd,OAAOksD,EAAUlsD,EAAI6sD,GAAS7sD,EAAG6sD,GAAS,IAE5C1rD,EAAM,SAAUnB,GACd,OAAOksD,EAAUlsD,EAAI6sD,IAIzBlwD,EAAOC,QAAU,CACfoiB,IAAKA,EACLra,IAAKA,EACLxD,IAAKA,EACLorD,QAASA,EACT5M,UAAWA,I,oCChEb,IAAIliD,EAAI,EAAQ,QACZyQ,EAAS,EAAQ,QACjBqD,EAAW,EAAQ,QACnBH,EAAW,EAAQ,QACnB07C,EAAyB,EAAQ,QACjC/B,EAAU,EAAQ,QAClBD,EAAa,EAAQ,QACrBvsD,EAAW,EAAQ,QACnBiG,EAAQ,EAAQ,QAChBuoD,EAA8B,EAAQ,QACtCC,EAAiB,EAAQ,QACzBC,EAAoB,EAAQ,QAEhCtwD,EAAOC,QAAU,SAAUyY,EAAkB+1C,EAASn3C,GACpD,IAAIo3C,GAA8C,IAArCh2C,EAAiBT,QAAQ,OAClCs4C,GAAgD,IAAtC73C,EAAiBT,QAAQ,QACnC02C,EAAQD,EAAS,MAAQ,MACzB8B,EAAoBj/C,EAAOmH,GAC3B+3C,EAAkBD,GAAqBA,EAAkB7tD,UACzD0P,EAAcm+C,EACdE,EAAW,GAEXC,EAAY,SAAUC,GACxB,IAAIC,EAAeJ,EAAgBG,GACnCn8C,EAASg8C,EAAiBG,EACjB,OAAPA,EAAe,SAAaxmD,GAE1B,OADAymD,EAAarwD,KAAKiB,KAAgB,IAAV2I,EAAc,EAAIA,GACnC3I,MACE,UAAPmvD,EAAkB,SAAUnhD,GAC9B,QAAO8gD,IAAY3uD,EAAS6N,KAAeohD,EAAarwD,KAAKiB,KAAc,IAARgO,EAAY,EAAIA,IAC1E,OAAPmhD,EAAe,SAAanhD,GAC9B,OAAO8gD,IAAY3uD,EAAS6N,QAAOlP,EAAYswD,EAAarwD,KAAKiB,KAAc,IAARgO,EAAY,EAAIA,IAC9E,OAAPmhD,EAAe,SAAanhD,GAC9B,QAAO8gD,IAAY3uD,EAAS6N,KAAeohD,EAAarwD,KAAKiB,KAAc,IAARgO,EAAY,EAAIA,IACjF,SAAaA,EAAKrF,GAEpB,OADAymD,EAAarwD,KAAKiB,KAAc,IAARgO,EAAY,EAAIA,EAAKrF,GACtC3I,QAKTwpD,EAAUr2C,EACZ8D,EAC4B,mBAArB83C,KAAqCD,GAAWE,EAAgBvqD,UAAY2B,GAAM,YACvF,IAAI2oD,GAAoBM,UAAUn+C,YAItC,GAAIs4C,EAEF54C,EAAciF,EAAOk3C,eAAeC,EAAS/1C,EAAkBg2C,EAAQC,GACvEwB,EAAuBY,UAAW,OAC7B,GAAIn8C,EAAS8D,GAAkB,GAAO,CAC3C,IAAI0wC,EAAW,IAAI/2C,EAEf2+C,EAAiB5H,EAASuF,GAAO4B,EAAU,IAAM,EAAG,IAAMnH,EAE1D6H,EAAuBppD,GAAM,WAAcuhD,EAAS5kD,IAAI,MAGxD0sD,EAAmBd,GAA4B,SAAUz8C,GAAY,IAAI68C,EAAkB78C,MAE3Fw9C,GAAcZ,GAAW1oD,GAAM,WAEjC,IAAIupD,EAAY,IAAIZ,EAChB1jD,EAAQ,EACZ,MAAOA,IAASskD,EAAUzC,GAAO7hD,EAAOA,GACxC,OAAQskD,EAAU5sD,KAAK,MAGpB0sD,IACH7+C,EAAco8C,GAAQ,SAAU4C,EAAO19C,GACrCw6C,EAAWkD,EAAOh/C,EAAaqG,GAC/B,IAAIrY,EAAOiwD,EAAkB,IAAIE,EAAqBa,EAAOh/C,GAE7D,YADgB9R,GAAZoT,GAAuBy6C,EAAQz6C,EAAUtT,EAAKsuD,GAAQ,CAAEtuD,KAAMA,EAAM4T,WAAYy6C,IAC7EruD,KAETgS,EAAY1P,UAAY8tD,EACxBA,EAAgBxsD,YAAcoO,IAG5B4+C,GAAwBE,KAC1BR,EAAU,UACVA,EAAU,OACVjC,GAAUiC,EAAU,SAGlBQ,GAAcH,IAAgBL,EAAUhC,GAGxC4B,GAAWE,EAAgBnuC,cAAcmuC,EAAgBnuC,MAU/D,OAPAouC,EAASh4C,GAAoBrG,EAC7BvR,EAAE,CAAEyQ,QAAQ,EAAMY,OAAQE,GAAem+C,GAAqBE,GAE9DL,EAAeh+C,EAAaqG,GAEvB63C,GAASj5C,EAAO03C,UAAU38C,EAAaqG,EAAkBg2C,GAEvDr8C,I,uBCrGT,IAAId,EAAS,EAAQ,QACjBE,EAA8B,EAAQ,QACtCjN,EAAM,EAAQ,QACdkQ,EAAY,EAAQ,QACpB48C,EAAgB,EAAQ,QACxB3O,EAAsB,EAAQ,QAE9BI,EAAmBJ,EAAoB36C,IACvCupD,EAAuB5O,EAAoBiN,QAC3C4B,EAAWtxD,OAAOA,QAAQ2L,MAAM,WAEnC7L,EAAOC,QAAU,SAAUuB,EAAGiO,EAAKrF,EAAOyJ,GACzC,IAGIsvC,EAHA3qC,IAAS3E,KAAYA,EAAQ2E,OAC7Bi5C,IAAS59C,KAAYA,EAAQmM,WAC7B5K,IAAcvB,KAAYA,EAAQuB,YAElB,mBAAThL,IACS,iBAAPqF,GAAoBjL,EAAI4F,EAAO,SACxCqH,EAA4BrH,EAAO,OAAQqF,GAE7C0zC,EAAQoO,EAAqBnnD,GACxB+4C,EAAMt2C,SACTs2C,EAAMt2C,OAAS2kD,EAASlvD,KAAmB,iBAAPmN,EAAkBA,EAAM,MAG5DjO,IAAM+P,GAIEiH,GAEApD,GAAe5T,EAAEiO,KAC3BgiD,GAAS,UAFFjwD,EAAEiO,GAIPgiD,EAAQjwD,EAAEiO,GAAOrF,EAChBqH,EAA4BjQ,EAAGiO,EAAKrF,IATnCqnD,EAAQjwD,EAAEiO,GAAOrF,EAChBsK,EAAUjF,EAAKrF,KAUrB/H,SAASM,UAAW,YAAY,WACjC,MAAsB,mBAARlB,MAAsBshD,EAAiBthD,MAAMoL,QAAUykD,EAAc7vD,U,uBCtCrF,IAAI2C,EAAc,EAAQ,QACtBg9C,EAAa,EAAQ,QACrBx+C,EAAkB,EAAQ,QAC1BmlD,EAAuB,EAAQ,QAA8CjlD,EAG7EwmD,EAAe,SAAUoI,GAC3B,OAAO,SAAUruD,GACf,IAKIoM,EALAjO,EAAIoB,EAAgBS,GACpBgb,EAAO+iC,EAAW5/C,GAClBlB,EAAS+d,EAAK/d,OACd8B,EAAI,EACJsI,EAAS,GAEb,MAAOpK,EAAS8B,EACdqN,EAAM4O,EAAKjc,KACNgC,IAAe2jD,EAAqBvnD,KAAKgB,EAAGiO,IAC/C/E,EAAOnE,KAAKmrD,EAAa,CAACjiD,EAAKjO,EAAEiO,IAAQjO,EAAEiO,IAG/C,OAAO/E,IAIX1K,EAAOC,QAAU,CAGf6wD,QAASxH,GAAa,GAGtBxkD,OAAQwkD,GAAa,K,qBC9BvB,SAASyC,EAAQhxC,GAiBf,MAdsB,oBAAXkH,QAAoD,kBAApBA,OAAOnO,UAChD9T,EAAOC,QAAU8rD,EAAU,SAAiBhxC,GAC1C,cAAcA,GAGhB/a,EAAOC,QAAQ,WAAaD,EAAOC,QAASD,EAAOC,QAAQ64B,YAAa,IAExE94B,EAAOC,QAAU8rD,EAAU,SAAiBhxC,GAC1C,OAAOA,GAAyB,oBAAXkH,QAAyBlH,EAAI9W,cAAgBge,QAAUlH,IAAQkH,OAAOtf,UAAY,gBAAkBoY,GAG3H/a,EAAOC,QAAQ,WAAaD,EAAOC,QAASD,EAAOC,QAAQ64B,YAAa,GAGnEizB,EAAQhxC,G,4DAGjB/a,EAAOC,QAAU8rD,EACjB/rD,EAAOC,QAAQ,WAAaD,EAAOC,QAASD,EAAOC,QAAQ64B,YAAa,G,qBCrBxE,IAAIl3B,EAAW,EAAQ,QACnB+vD,EAAiB,EAAQ,QAG7B3xD,EAAOC,QAAU,SAAUupD,EAAO6H,EAAOO,GACvC,IAAIC,EAAWC,EAUf,OAPEH,GAE0C,mBAAlCE,EAAYR,EAAMptD,cAC1B4tD,IAAcD,GACdhwD,EAASkwD,EAAqBD,EAAUlvD,YACxCmvD,IAAuBF,EAAQjvD,WAC/BgvD,EAAenI,EAAOsI,GACjBtI,I,mBCdTvpD,EAAQ6C,EAAII,OAAOwlD,uB,8CCDnB,IAAItoC,EAAO,EAAQ,QACf5b,EAAM,EAAQ,QACdutD,EAA+B,EAAQ,QACvChqD,EAAiB,EAAQ,QAAuCjF,EAEpE9C,EAAOC,QAAU,SAAU+xD,GACzB,IAAI/vC,EAAS7B,EAAK6B,SAAW7B,EAAK6B,OAAS,IACtCzd,EAAIyd,EAAQ+vC,IAAOjqD,EAAeka,EAAQ+vC,EAAM,CACnD5nD,MAAO2nD,EAA6BjvD,EAAEkvD,O,sFCE3B,qCAEN,CACP9tD,KADO,QAGPmE,MAAO,CACL4pD,KAAM,CACJvpD,KADI,QAEJC,aAASpI,GAEXmiB,GAAI,CACFha,KADE,OAEFC,QAAS,OAEXupD,MAAO,CACLxpD,KADK,QAELC,aAASpI,IAIbgO,SAAU,CACR4jD,OADQ,WAEN,OAAO1wD,KAAK8iD,SAAS6N,MAArB,OAIJ/3C,aAxBO,WAyBL,IAAK5Y,KAAD,UAAmBA,KAAK8iD,WAAa9iD,KAAzC,MACE,MAAM,IAAI6+C,MAAV,gIAIJt2C,OA9BO,SA8BD,GACJ,IAAMykD,EAAUpkD,EAAE,MAAO,CAAEC,YAAa,uBAAyB7I,KAAKuN,OAAtE,SAEA,OAAO3E,EAAE,MAAO,CACdC,YADc,gBAEdC,MAAO,gBACL,wBAAyB9I,KAAK8iD,SADzB,IAEL,yBAA0B9iD,KAAK8iD,SAF1B,KAGF9iD,KAAK4O,cAEVV,MAAO,CAAE,YAAY,GACrB2hB,SAAU,CAAE5O,GAAIjhB,KAAKihB,KACpB,CATH,Q,4DCnCE2vC,EAAY,uBAA6B,CAC7CnuD,KAD6C,YAG7CikB,QAH6C,WAI3C,MAAO,CACLiqC,MAAO3wD,KAAK6wD,mBAIhBpqC,OAAQ,CACNkqC,MAAO,CACLzpD,QAAS,CACPwpD,QAAQ,KAKd9pD,MAAO,CACL4pD,KAAM,CACJvpD,KADI,QAEJC,QAAS,MAEXupD,MAAO,CACLxpD,KADK,QAELC,QAAS,OAIbjC,KA5B6C,WA6B3C,MAAO,CACL4rD,iBAAkB,CAChBH,QAAQ,KAKd5jD,SAAU,CACRgkD,UADQ,WAEN,OAAO9wD,KAAK8iD,SAAS6N,MAAMH,OAA3B,GAEFE,OAJQ,WAKN,WAAI1wD,KAAKwwD,OAGF,IAAIxwD,KAAKywD,OAKPzwD,KAAK2wD,MAAZ,QAGJ/hD,aAhBQ,WAiBN,MAAO,CACL,cAAe5O,KADV,OAEL,gBAAiBA,KAAK0wD,SAI1BK,WAvBQ,WAwBN,WAAI/wD,KAAKwwD,OAGF,IAAIxwD,KAAKywD,OAKPzwD,KAAP,WAGJgxD,iBAnCQ,WAoCN,MAAO,CACL,cAAehxD,KADV,WAEL,gBAAiBA,KAAK+wD,cAK5BnxC,MAAO,CACL8wC,OAAQ,CACNvnC,QADM,SACC,KACD5D,IAAJ,IACEvlB,KAAA,wBAA+BA,KAA/B,SAGJ+/B,WAAW,MAKjB,U,mBCpGAxhC,EAAOC,QAAU,CACf,cACA,iBACA,gBACA,uBACA,iBACA,WACA,Y,oCCAF,SAASyyD,EAAOtS,GACd3+C,KAAK2+C,QAAUA,EAGjBsS,EAAO/vD,UAAUI,SAAW,WAC1B,MAAO,UAAYtB,KAAK2+C,QAAU,KAAO3+C,KAAK2+C,QAAU,KAG1DsS,EAAO/vD,UAAU49C,YAAa,EAE9BvgD,EAAOC,QAAUyyD,G,oCChBjB,IAAIztD,EAAQ,EAAQ,QAEpBjF,EAAOC,QACLgF,EAAM+8C,uBAGN,WACE,MAAO,CACL2Q,MAAO,SAAezuD,EAAMkG,EAAOwoD,EAASxyC,EAAMyyC,EAAQC,GACxD,IAAIC,EAAS,GACbA,EAAOxsD,KAAKrC,EAAO,IAAMu8C,mBAAmBr2C,IAExCnF,EAAM+tD,SAASJ,IACjBG,EAAOxsD,KAAK,WAAa,IAAI2X,KAAK00C,GAASK,eAGzChuD,EAAMy9C,SAAStiC,IACjB2yC,EAAOxsD,KAAK,QAAU6Z,GAGpBnb,EAAMy9C,SAASmQ,IACjBE,EAAOxsD,KAAK,UAAYssD,IAGX,IAAXC,GACFC,EAAOxsD,KAAK,UAGdqlB,SAASmnC,OAASA,EAAOzwD,KAAK,OAGhC4wD,KAAM,SAAchvD,GAClB,IAAIuD,EAAQmkB,SAASmnC,OAAOtrD,MAAM,IAAImF,OAAO,aAAe1I,EAAO,cACnE,OAAQuD,EAAQ0rD,mBAAmB1rD,EAAM,IAAM,MAGjDsU,OAAQ,SAAgB7X,GACtBzC,KAAKkxD,MAAMzuD,EAAM,GAAIga,KAAK6f,MAAQ,SA/BxC,GAqCA,WACE,MAAO,CACL40B,MAAO,aACPO,KAAM,WAAkB,OAAO,MAC/Bn3C,OAAQ,cAJZ,I,uBC7CF,IAAIvR,EAAyB,EAAQ,QAIrCxK,EAAOC,QAAU,SAAUqqD,GACzB,OAAOpnD,OAAOsH,EAAuB8/C,M,0XCgBjC,cACJ,QAAO,KAAa8I,EAAA,MAApB,8BAGI,cACJ,MAEA,qBAAWA,EACTC,EAAA,MACK,sBAAWD,EAUhB,MAAM,IAAI9hD,UAAU,mDAAd,OAAiE,MAAA8hD,IAAwBA,EAAA,YAA/F,KAAM,aATN,IAAIzyD,EAAI,MAAAyyD,EAAA,GAAmBA,EAAA,UAAnB,GAAR,EACA,IAAIzyD,EAAA,SACFA,EAAIA,EAAA,eAAgB,SAAA2yD,GAAI,OAAIA,EAAxB,UAAJ,KAEF,IAAI3yD,EAAA,QACF,eAAY,IAAD,OAAX,EAAW,+BAEb0yD,EAAMpuB,SAAStkC,EAAf,IAaF,OARI0yD,EAAJ,GACE,eAAY,+BAAD,OAAX,EAAW,MACXA,EAAA,IACSA,EAAA,UAAkB53C,MAAtB,MACL,eAAY,IAAD,OAAX,EAAW,+BACX43C,EAAA,UAGF,EAyBI,cACJ,IAAIE,EAAmBH,EAAA,SAAvB,IAIA,OAFIG,EAAA,OAAJ,IAAyBA,EAAW,IAAIxR,OAAO,EAAIwR,EAAf,QAAXA,GAElB,IAAP,EAGI,cACJ,OAAOC,EAASC,EAAhB,M,uBCrFF,IAmDIC,EAnDA3oD,EAAW,EAAQ,QACnB2Z,EAAmB,EAAQ,QAC3BnP,EAAc,EAAQ,QACtBC,EAAa,EAAQ,QACrBupC,EAAO,EAAQ,QACf4U,EAAwB,EAAQ,QAChClE,EAAY,EAAQ,QAEpBmE,EAAK,IACLC,EAAK,IACLC,EAAY,YACZC,EAAS,SACTC,EAAWvE,EAAU,YAErBwE,EAAmB,aAEnBC,EAAY,SAAUC,GACxB,OAAON,EAAKE,EAASH,EAAKO,EAAUN,EAAK,IAAME,EAASH,GAItDQ,EAA4B,SAAUV,GACxCA,EAAgBf,MAAMuB,EAAU,KAChCR,EAAgBW,QAChB,IAAIC,EAAOZ,EAAgBa,aAAarxD,OAExC,OADAwwD,EAAkB,KACXY,GAILE,EAA2B,WAE7B,IAEIC,EAFAC,EAASf,EAAsB,UAC/BgB,EAAK,OAASZ,EAAS,IAU3B,OARAW,EAAOzkD,MAAMirC,QAAU,OACvB6D,EAAK1W,YAAYqsB,GAEjBA,EAAOxuC,IAAMhmB,OAAOy0D,GACpBF,EAAiBC,EAAOE,cAAchpC,SACtC6oC,EAAeI,OACfJ,EAAe9B,MAAMuB,EAAU,sBAC/BO,EAAeJ,QACRI,EAAe1L,GASpB+L,EAAkB,WACpB,IAEEpB,EAAkB9nC,SAASinC,QAAU,IAAIkC,cAAc,YACvD,MAAOzxD,IACTwxD,EAAkBpB,EAAkBU,EAA0BV,GAAmBc,IACjF,IAAIl0D,EAASiV,EAAYjV,OACzB,MAAOA,WAAiBw0D,EAAgBhB,GAAWv+C,EAAYjV,IAC/D,OAAOw0D,KAGTt/C,EAAWw+C,IAAY,EAIvBh0D,EAAOC,QAAUiD,OAAO2Y,QAAU,SAAgBra,EAAG6/C,GACnD,IAAI32C,EAQJ,OAPU,OAANlJ,GACFyyD,EAAiBH,GAAa/oD,EAASvJ,GACvCkJ,EAAS,IAAIupD,EACbA,EAAiBH,GAAa,KAE9BppD,EAAOspD,GAAYxyD,GACdkJ,EAASoqD,SACMv0D,IAAf8gD,EAA2B32C,EAASga,EAAiBha,EAAQ22C,K,oCC3EtE,IAAIvgD,EAAI,EAAQ,QACZk0D,EAAQ,EAAQ,QAAgCC,KAChDC,EAAmB,EAAQ,QAE3BC,EAAO,OACPC,GAAc,EAGdD,IAAQ,IAAIxxD,MAAM,GAAGwxD,IAAM,WAAcC,GAAc,KAI3Dt0D,EAAE,CAAEM,OAAQ,QAASC,OAAO,EAAM8Q,OAAQijD,GAAe,CACvDH,KAAM,SAAcjjD,GAClB,OAAOgjD,EAAMvzD,KAAMuQ,EAAYnR,UAAUP,OAAS,EAAIO,UAAU,QAAKN,MAKzE20D,EAAiBC,I,oCCnBjB,IAAIr0D,EAAI,EAAQ,QACZu0D,EAA4B,EAAQ,QACpCnU,EAAiB,EAAQ,QACzByQ,EAAiB,EAAQ,QACzBtB,EAAiB,EAAQ,QACzB5+C,EAA8B,EAAQ,QACtCgD,EAAW,EAAQ,QACnB5U,EAAkB,EAAQ,QAC1By+C,EAAU,EAAQ,QAClB6C,EAAY,EAAQ,QACpBmU,EAAgB,EAAQ,QAExBC,EAAoBD,EAAcC,kBAClCC,EAAyBF,EAAcE,uBACvCjjD,EAAW1S,EAAgB,YAC3B41D,EAAO,OACPC,EAAS,SACTC,EAAU,UAEVC,EAAa,WAAc,OAAOn0D,MAEtCzB,EAAOC,QAAU,SAAU41D,EAAU7D,EAAM8D,EAAqBnjD,EAAMojD,EAASC,EAAQnhD,GACrFwgD,EAA0BS,EAAqB9D,EAAMr/C,GAErD,IAkBIsjD,EAA0BpnD,EAAS+hD,EAlBnCsF,EAAqB,SAAUC,GACjC,GAAIA,IAASJ,GAAWK,EAAiB,OAAOA,EAChD,IAAKZ,GAA0BW,KAAQE,EAAmB,OAAOA,EAAkBF,GACnF,OAAQA,GACN,KAAKV,EAAM,OAAO,WAAkB,OAAO,IAAIK,EAAoBr0D,KAAM00D,IACzE,KAAKT,EAAQ,OAAO,WAAoB,OAAO,IAAII,EAAoBr0D,KAAM00D,IAC7E,KAAKR,EAAS,OAAO,WAAqB,OAAO,IAAIG,EAAoBr0D,KAAM00D,IAC/E,OAAO,WAAc,OAAO,IAAIL,EAAoBr0D,QAGpD3B,EAAgBkyD,EAAO,YACvBsE,GAAwB,EACxBD,EAAoBR,EAASlzD,UAC7B4zD,EAAiBF,EAAkB9jD,IAClC8jD,EAAkB,eAClBN,GAAWM,EAAkBN,GAC9BK,GAAmBZ,GAA0Be,GAAkBL,EAAmBH,GAClFS,EAA4B,SAARxE,GAAkBqE,EAAkBvF,SAA4ByF,EAiCxF,GA7BIC,IACFP,EAA2B/U,EAAesV,EAAkBh2D,KAAK,IAAIq1D,IACjEN,IAAsBryD,OAAOP,WAAaszD,EAAyBtjD,OAChE2rC,GAAW4C,EAAe+U,KAA8BV,IACvD5D,EACFA,EAAesE,EAA0BV,GACa,mBAAtCU,EAAyB1jD,IACzCd,EAA4BwkD,EAA0B1jD,EAAUqjD,IAIpEvF,EAAe4F,EAA0Bn2D,GAAe,GAAM,GAC1Dw+C,IAAS6C,EAAUrhD,GAAiB81D,KAKxCG,GAAWL,GAAUa,GAAkBA,EAAeryD,OAASwxD,IACjEY,GAAwB,EACxBF,EAAkB,WAAoB,OAAOG,EAAe/1D,KAAKiB,QAI7D68C,IAAWzpC,GAAWwhD,EAAkB9jD,KAAc6jD,GAC1D3kD,EAA4B4kD,EAAmB9jD,EAAU6jD,GAE3DjV,EAAU6Q,GAAQoE,EAGdL,EAMF,GALAlnD,EAAU,CACR/J,OAAQoxD,EAAmBR,GAC3Br3C,KAAM23C,EAASI,EAAkBF,EAAmBT,GACpD3E,QAASoF,EAAmBP,IAE1B9gD,EAAQ,IAAK+7C,KAAO/hD,GAClB2mD,GAA0Bc,KAA2B1F,KAAOyF,KAC9D5hD,EAAS4hD,EAAmBzF,EAAK/hD,EAAQ+hD,SAEtC9vD,EAAE,CAAEM,OAAQ4wD,EAAM3wD,OAAO,EAAM8Q,OAAQqjD,GAA0Bc,GAAyBznD,GAGnG,OAAOA,I,oCCxFT,gBAOA,SAAS4nD,EAAT,GACE,OAAO,SAAU,EAAV,GACL,IAAK,IAAL,OACOvzD,OAAA,gCAAL,IACEzB,KAAA,QAAaA,KAAKi1D,MAAlB,MAGJ,IAAK,IAAL,OACEj1D,KAAA,KAAUA,KAAKi1D,MAAf,KAAsCltD,EAAtC,KAKS,qBAAW,CACxB9C,KAAM,iBAAO,CACXkJ,OADW,GAEXjB,WAAY,KAGdk2B,QANwB,WAStBpjC,KAAA,gBAAsBg1D,EAAtB,UAA6C,CAAEj1B,WAAW,IAC1D//B,KAAA,oBAA0Bg1D,EAA1B,cAAqD,CAAEj1B,WAAW,Q,uBC9BtE,IAAIjwB,EAAS,EAAQ,QACjB+/C,EAAgB,EAAQ,QAExB3B,EAAUp+C,EAAOo+C,QAErB3vD,EAAOC,QAA6B,oBAAZ0vD,GAA0B,cAAc5vD,KAAKuxD,EAAc3B,K,8zBCA7E,cAGS,IADbpzB,EACa,uDAHT,QAGS,uCAEb,OAAO,cAAW,CAChBr4B,KAAMA,GAAQvD,EAAA,cADE,KAGhBiJ,YAHgB,EAKhBI,OALgB,SAKV,EALU,GAKa,IAAlB,EAAkB,EAAlB,KAAQC,EAAU,EAAVA,SAGjB,OAFAvD,EAAA,YAAoB,UAAG/F,EAAH,YAAQ+F,EAAA,aAAT,IAAnB,OAEO2D,EAAEkyB,EAAI71B,EAAb,MA8BN,IACE,wBAAWzD,OAAwB,CACjC,IAAM0zD,EAAmBzzD,OAAA,4BAAqC,CAC5D8E,IAAK,YACH,KAIJ/E,OAAA,qCACAA,OAAA,yCAEF,MAAOuK,GAAKud,QAAA,QAYR,kBACJ,IAAMuD,EAAOlO,EAAA,OAAb,EAEA,GAAIkO,EAAJ,EAAc,YAAO,IAAAvT,EAAA,EAAP,EAEd,IAAK,IAAI3Y,EAAT,EAAgBA,EAAhB,EAA0BA,IAAK,CAC7B,SAAI2Y,EACF,SAEFA,EAAMA,EAAIqF,EAAV,IAGF,aAAIrF,QAEG,IAAAA,EAAIqF,EAAJ,IAFiB8P,EAE0BnV,EAAIqF,EAAtD,IA8BI,kBAEJ,OAAI,MAAArF,GAAA,GAAJ,kBAAmCqF,OACnC,IAAIrF,EAAA,GAAgCA,EAAP,IAC7BqF,EAAOA,EAAA,qBAJmE,OAK1EA,EAAOA,EAAA,cALmE,IAMnEw2C,EAAe77C,EAAKqF,EAAA,MAAN,KAArB,IAJ6D8P,EAkDzD,gBAGJ,IAFA,IAAM2mC,EAAN,GAESz0D,EAAT,EAAgBA,EAAIic,EAApB,OAAiCjc,IAAK,CACpC,IAAMqN,EAAM4O,EAAZ,GACA,qBAAWtD,EAAP,KACF87C,EAAA,GAAgB97C,EAAhB,IAIJ,SAGI,cAA6E,IAAX+7C,EAAW,uDAA7E,KACJ,OAAI,MAAA7vD,GAAJ,KAAmBA,OACjB,EACSwU,OAAJ,GACEvb,OAAP,GAEA,UAAUmO,OAAOpH,IAAjB,UAQE,cACJ,OAAO,OAAA8T,GAAP,WAAuB,kBAIlB,IAAMqE,EAAWlc,OAAA,OAAc,CACpC8zC,MADoC,GAEpC+f,IAFoC,EAGpCxxB,OAHoC,GAIpCyxB,IAJoC,GAKpCC,MALoC,GAMpCC,GANoC,GAOpCC,KAPoC,GAQpCjpD,KARoC,GASpCC,MAToC,GAUpCs+B,IAVoC,GAWpC2qB,KAXoC,GAYpCnwC,IAZoC,GAapCowC,UAboC,EAcpC5hC,OAdoC,GAepC6hC,OAfoC,GAgBpCC,SAhBoC,GAiBpC9wD,MAAO,KAOH,gBAEJ,IAAMwK,EAAYyW,EAAA,eAFwC,UAK1D,GAAI3Y,EAAA,WAAJ,KAA8B,CAE5B,IAAMyoD,EAAW,yBAAH,OAA4BzoD,EAAA,4BAFd,OAMtB0oD,EAAWC,EAAqBhwC,EAAI8vC,EAA1C,GAEA,qBAAWC,EACN,OAAOA,EADsB1oD,EAAlC,EAIF,aAAIkC,EACF,EAGK,CACLA,YACA5I,MAAO,CACLyF,KAAMiB,IAKN,cACJ,OAAO7L,OAAA,KAAP,GAMF,IAAMoZ,EAAN,SACaC,EAAY,SAAAtV,GACvB,OAAOA,EAAA,WAAwB,qBAAUtG,EAAIA,EAAH,cAA1C,OAiBI,cACJ,OAAOsG,EAAA,wBAA8BA,EAAA,MAArC,GA0BI,cAAgE,OAAO,MAAAyT,EAAY/W,MAAA,aAAuB,CAAnC+W,GAAP,GAuGhE,cAA8F,IAAlExW,EAAkE,uDAA9F,YAA8F,uCAAhByzD,EAAgB,wDAClG,OAAIjwC,EAAA,aAAJ,GACSA,EAAA,gBAAuBhhB,aAAA,SAA2BA,IAAzD,IACSghB,EAAA,WAAqBhhB,IAAzB,SACEghB,EAAA,OAAP,GAKE,cAAgD,IAAhBnc,EAAgB,uDAAhD,EAAyCgJ,EAAO,uDAAhD,EACJ,OAAO3N,KAAA,MAAcA,KAAA,MAArB,IAGI,gBAAyD,IAAV0sD,EAAU,uDAAzD,IACJ,OAAOrsD,EAAMqsD,EAAA,OAAY1sD,KAAA,MAAYtG,EAAS2G,EAA9C,SAGI,cAAsC,IAARmH,EAAQ,uDAAtC,EACEwpD,EAAN,GACI9qD,EAAJ,EACA,MAAOA,EAAQ7F,EAAf,OACE2wD,EAAA,KAAa3wD,EAAA,SAAb,IACA6F,GAAA,EAEF,SA2BI,aAEwB,IAD5BD,EAC4B,uDAFxB,GAEJzL,EAA4B,uDAFxB,GAIJ,IAAK,IAAL,OAA0B,CACxB,IAAM2T,EAAiBlI,EAAvB,GACMiI,EAAiB1T,EAFC,GAOtBQ,EAAA,IACAA,EAFF,GAIEiL,EAAA,GAAcgrD,EAAU9iD,EAAxB,GAKFlI,EAAA,KAGF,W,oCCheF,IAAI7L,EAAW,EAAQ,QACnBqoD,EAAkB,EAAQ,QAC1BpoD,EAAW,EAAQ,QAIvBjB,EAAOC,QAAU,SAAcmK,GAC7B,IAAI5I,EAAIR,EAASS,MACbnB,EAASW,EAASO,EAAElB,QACpB0pD,EAAkBnpD,UAAUP,OAC5BwM,EAAQu8C,EAAgBW,EAAkB,EAAInpD,UAAU,QAAKN,EAAWD,GACxEmsC,EAAMud,EAAkB,EAAInpD,UAAU,QAAKN,EAC3Cu3D,OAAiBv3D,IAARksC,EAAoBnsC,EAAS+oD,EAAgB5c,EAAKnsC,GAC/D,MAAOw3D,EAAShrD,EAAOtL,EAAEsL,KAAW1C,EACpC,OAAO5I,I,uBCfT,IAAII,EAAW,EAAQ,QAEvB5B,EAAOC,QAAU,SAAUoD,GACzB,IAAKzB,EAASyB,GACZ,MAAMiO,UAAUpR,OAAOmD,GAAM,qBAC7B,OAAOA,I,gICFX,S,0DCae,gBAAiB,CAC9Ba,KAD8B,sBAG9BwkB,WAAY,CAAEqvC,YAAA,MAEd1vD,MAAO,CACL2vD,OADK,QAELC,cAFK,QAGLC,OAAQ,CACNxvD,KAAM,CAAC2F,OADD,QAEN1F,QAAS,GAEXyF,KAAM,CACJ1F,KAAM,CAAC2F,OADH,QAEJ1F,QAAS,IAEXwH,MAAO,CACLzH,KAAM,CAAC2F,OADF,QAEL1F,QAAS,GAEXyB,MAAO,CACL1B,KAAM,CAAC2F,OADF,QAEL1F,QAAS,IAIbjC,KAAM,iBAAO,CACXyxD,OADW,GAEXC,WAAW,IAGb7pD,SAAU,CACR8pD,eADQ,WAEN,OAAOhqD,OAAO5M,KAAP,OAAqBA,KAAKu2D,OAAS,EAA1C,IAGFM,cALQ,WAMN,OAAO,EAAI1xD,KAAJ,GAAcnF,KAArB,QAGF+iD,QATQ,WAUN,MAAO,CACL,+BAAgC/iD,KAD3B,UAEL,qCAAsCA,KAFjC,cAGL,8BAA+BA,KAAKu2D,SAIxCO,gBAjBQ,WAkBN,OAAI92D,KAAK2I,MAAT,EACE,EAGE3I,KAAK2I,MAAT,IACE,IAGK+Q,WAAW1Z,KAAlB,QAGF+2D,gBA7BQ,WA8BN,OAAO5xD,KAAA,UAAWnF,KAAK62D,eAAvB,KAGFG,iBAjCQ,WAkCN,OAAS,IAAMh3D,KAAP,iBAAD,IAAuCA,KAAvC,cAAP,MAGFi3D,YArCQ,WAsCN,OAAOrqD,OAAO5M,KAAP,QAAsBA,KAAtB,KAAkCA,KAAlC,YAAP,GAGFmW,OAzCQ,WA0CN,MAAO,CACL1H,OAAQ,eAAczO,KADjB,gBAEL0O,MAAO,eAAc1O,KAAD,kBAIxBk3D,UAhDQ,WAiDN,MAAO,CACLlb,UAAW,UAAF,OAAYpvC,OAAO5M,KAAD,QAAlB,UAIbm3D,YAtDQ,WAuDN,OAAOn3D,KAAK02D,QAAU,EAAI9pD,OAAO5M,KAAP,QAAsBA,KAAhD,QAIJoN,QAAS,CACPgqD,UADO,SACE,KACP,OAAOp3D,KAAK8uB,eAAe,SAAU,CACnChmB,MAAO,wBAAF,OAD8B,GAEnCoF,MAAO,CACLmpD,KADK,cAELC,GAAI,EAAIt3D,KAFH,YAGLu3D,GAAI,EAAIv3D,KAHH,YAILw3D,EAAGx3D,KAJE,OAKL,eAAgBA,KALX,YAML,mBAAoBA,KANf,gBAOL,oBAAqBgsD,MAI3ByL,OAfO,WAgBL,IAAMjvD,EAAW,CACfxI,KAAKw2D,eAAiBx2D,KAAKo3D,UAAU,WADtB,GAEfp3D,KAAKo3D,UAAU,UAAWp3D,KAF5B,mBAKA,OAAOA,KAAK8uB,eAAe,MAAO,CAChCtgB,MAAOxO,KADyB,UAEhCkO,MAAO,CACLiB,MADK,6BAELC,QAAS,GAAF,OAAKpP,KAAKm3D,YAAV,YAAyBn3D,KAAKm3D,YAA9B,YAA6C,EAAIn3D,KAAKm3D,YAAtD,YAAqE,EAAIn3D,KAAKm3D,eAJzF,IAQFO,QA7BO,WA8BL,OAAO13D,KAAK8uB,eAAe,MAAO,CAChCjmB,YAAa,6BACZ7I,KAAKuN,OAFR,UAIFoqD,UAlCO,SAkCE,OACP33D,KAAA,cAIJuI,OAjI8B,SAiIxB,GACJ,OAAOK,EAAE,MAAO5I,KAAK43D,aAAa53D,KAAlB,MAA8B,CAC5C6I,YAD4C,sBAE5CqF,MAAO,CACLmB,KADK,cAEL,gBAFK,EAGL,gBAHK,IAIL,gBAAiBrP,KAAKw2D,mBAAgB13D,EAAYkB,KAAK82D,iBAEzDhuD,MAAO9I,KARqC,QAS5CinB,WAAY,CAAC,CACXxkB,KADW,YAEXkG,MAAO3I,KAAK23D,YAEdnpD,MAAOxO,KAbqC,OAc5CoO,GAAIpO,KAAKw7B,aACP,CACFx7B,KADE,SAEFA,KAjBF,eC/IJ,I,oCCCA,SAAS63D,EAAT,KACE,OAAO,kBAAM,OAAAvuC,EAAA,MAAY,OAAD,OAAQtG,EAAR,4CAAxB,KAUI,kBAGJ,IAAM80C,EAAc90C,GAAA,EAAkB,CACpC+0C,SAAUF,EAAgB70C,EADU,GAEpCg1C,WAAYH,EAAgB70C,EAAO/K,IAFrC,KAKA,OAAO,cAAW,CAChBxV,KADgB,qBAGhBgkB,OAAQ,kBACN,EAAa,CACXvf,QAAS4wD,MCZX,kBAKJ,OAAO,EAAiB,IAAjB,UAAyD,CAC9Dr1D,KAD8D,YAG9DmE,MAAO,CACL6vC,YAAa,CACXxvC,KADW,OAEXC,QAFW,WAGT,GAAKlH,KAAL,GAEA,OAAOA,KAAKsmC,GAAZ,cAGJ95B,SAAUS,SAGZhI,KAf8D,WAgB5D,MAAO,CACLq/C,UAAU,IAIdx3C,SAAU,CACRmrD,aADQ,WAEN,OAAKj4D,KAAL,YAEA,kBACGA,KAAD,YAAoBA,KAAKskD,UAHG,KAQlClhB,QA/B8D,WAgC5DpjC,KAAA,IAAoBA,KAAKsmC,GAAL,SAApBtmC,OAGFk4D,cAnC8D,WAoC5Dl4D,KAAA,IAAoBA,KAAKsmC,GAAL,WAApBtmC,OAGFoN,QAAS,CACP+qD,OADO,WAELn4D,KAAA,oBAOUu3B,EAAlB,iB,oCC3DM6gC,G,oGAAa53C,OAAnB,eAIM63C,EAAN,GAEA,SAASrc,EAAT,KACElhB,EAAA,kBACAA,EAAA,wBAGF,SAASurB,EAAT,KACEvrB,EAAA,cAAmBnyB,EAAnB,WASF,SAAS2vD,EAAT,GACE,qBAAOvsD,EAAA,iBAGT,SAASwsD,EAAT,GACE,wBAAOxsD,EAAA,iBAGT,IAAMysD,EAAY,SAAC,EAAD,GAId,IADF7vD,EACE,uDAJc,GAKZ8vD,EAAJ,EACIC,EAAJ,EAEA,IAAKH,EAAL,GAAyB,CACvB,IAAMvM,EAASlxB,EAAf,wBACMn7B,EAAS24D,EAAA,GAAkBvsD,EAAA,QAAUA,EAAA,eAA5B,GAAf,EAEA0sD,EAAS94D,EAAA,QAAiBqsD,EAA1B,KACA0M,EAAS/4D,EAAA,QAAiBqsD,EAA1B,IAGF,IAAI0K,EAAJ,EACIiC,EAAJ,GACI79B,EAAA,SAAcA,EAAA,QAAlB,QACE69B,EAAA,IACAjC,EAAS57B,EAAA,YAAT,EACA47B,EAAS/tD,EAAA,SAAwB+tD,EAASvxD,KAAA,KAAU,SAACszD,EAAD,cAA0BC,EAAD,EAAnC,IAA1C,GAEAhC,EAASvxD,KAAA,KAAU,SAAA21B,EAAA,wBAAsBA,EAAA,aAAhC,IAAT,EAGF,IAAM89B,EAAU,GAAH,QAAO99B,EAAA,YAAD,EAAmB47B,GAAtC,EAAa,MACPmC,EAAU,GAAH,QAAO/9B,EAAA,aAAD,EAAoB47B,GAAvC,EAAa,MAEP3U,EAAIp5C,EAAA,mBAA4B8vD,EAAtC,EAAU,MACJK,EAAInwD,EAAA,mBAA4B+vD,EAAtC,EAAU,MAEV,MAAO,CAAEhC,SAAQiC,QAAO5W,IAAG+W,IAAGF,UAASC,YAGnCE,EAAU,CAEd5hB,KAFc,SAEV,KAGuB,IAAzBxuC,EAAyB,uDAHvB,GAKF,GAAKmyB,EAAD,SAAgBA,EAAA,QAApB,SAIA,IAAMk+B,EAAY7uC,SAAA,cAAlB,QACM8uC,EAAY9uC,SAAA,cAAlB,QAEA6uC,EAAA,eACAA,EAAA,gCAEIrwD,EAAJ,QACEqwD,EAAA,sBAA2BrwD,EAA3B,QAGF,MAAkD6vD,EAAUzsD,EAAG+uB,EAA/D,GAAM,EAAN,EAAM,SAAN,EAAM,QAAN,EAAM,IAAN,EAAM,IAAN,EAAM,QAAgC+9B,EAAtC,EAAsCA,QAEhClsD,EAAO,GAAH,OAAV,EAAgB+pD,EAAN,MACVuC,EAAA,gCACAA,EAAA,cACAA,EAAA,eAEAn+B,EAAA,eAEA,IAAMhuB,EAAWtL,OAAA,iBAAjB,GACIsL,GAAJ,WAAgBA,EAAA,WACdguB,EAAA,0BACAA,EAAA,mCAGFm+B,EAAA,4CACAA,EAAA,8CACAjd,EAAUid,EAAW,aAAZ,OAAyBlX,EAAzB,aAA+B+W,EAA/B,qBAA6CH,EAA7C,YAAsDA,EAAtD,YAAT,EAAS,MACTtS,EAAQ4S,EAAR,GACAA,EAAA,kBAA8Bx6D,OAAO8e,YAArC,OAEAsM,YAAW,WACTovC,EAAA,+CACAA,EAAA,yCACAjd,EAAUid,EAAW,aAAZ,OAAyBL,EAAzB,aAAT,EAAS,qBACTvS,EAAQ4S,EAAR,OAJF,KAQFC,KAlDc,SAkDV,GACF,GAAKp+B,GAAOA,EAAR,SAAuBA,EAAA,QAA3B,SAEA,IAAMi+B,EAAUj+B,EAAA,uBAAhB,uBAEA,OAAIi+B,EAAA,OAAJ,CACA,IAAME,EAAYF,EAAQA,EAAA,OAA1B,GAEA,IAAIE,EAAA,QAAJ,UACKA,EAAA,wBAEL,IAAME,EAAO57C,YAAA,MAAoB3Q,OAAOqsD,EAAA,QAAxC,WACMzgC,EAAQrzB,KAAA,IAAS,IAAT,EAAd,GAEA0kB,YAAW,WACTovC,EAAA,4CACAA,EAAA,0CACA5S,EAAQ4S,EAAR,GAEApvC,YAAW,WACT,IAAMkvC,EAAUj+B,EAAA,uBAAhB,uBACI,IAAAi+B,EAAA,QAAwBj+B,EAAA,QAA5B,mBACEA,EAAA,eAAoBA,EAAA,QAApB,wBACOA,EAAA,QAAP,kBAGFm+B,EAAA,YAAwBn+B,EAAA,YAAem+B,EAAvC,cAPF,OALF,QAkBJ,SAASG,EAAT,GACE,MAAwB,qBAAVzwD,KAAd,EAGF,SAAS0wD,EAAT,GACE,IAAM1wD,EAAN,GACM2wD,EAAUvtD,EAAhB,cAEA,GAAKutD,GAAYA,EAAb,UAAgCA,EAAA,QAAhC,UAA2DvtD,EAA/D,IAKA,GAFAA,EAAA,MAEIusD,EAAJ,GACEgB,EAAA,mBACAA,EAAA,wBAMA,GAAIA,EAAA,QAAJ,QAA6B,OAO/B,GALA3wD,EAAA,OAAe2wD,EAAA,kBAA4Bf,EAA3C,GACIe,EAAA,QAAJ,QACE3wD,EAAA,MAAc2wD,EAAA,QAAd,OAGEhB,EAAJ,GAAqB,CAEnB,GAAIgB,EAAA,QAAJ,gBAAqC,OAErCA,EAAA,wBAAkC,WAChCP,EAAA,aAEFO,EAAA,kBAA4B93D,OAAA,YAAkB,WACxC83D,GAAWA,EAAX,SAA8BA,EAAA,QAAlC,kBACEA,EAAA,0BACAA,EAAA,gCAHJ,QAOAP,EAAA,aAIJ,SAASQ,EAAT,GACE,IAAMD,EAAUvtD,EAAhB,cACA,GAAKutD,GAAYA,EAAjB,SAMA,GAJA93D,OAAA,aAAoB83D,EAAA,QAJO,WAQvB,aAAAvtD,EAAA,MAAyButD,EAAA,QAA7B,gBAQE,OAPAA,EAAA,0BACAA,EAAA,wBAF4D,UAK5DA,EAAA,kBAA4BzvC,YAAW,WACrC0vC,EAAA,OAKJ/3D,OAAA,YAAkB,WACZ83D,EAAJ,UACEA,EAAA,uBAGJP,EAAA,SAGF,SAASS,EAAT,GACE,IAAMF,EAAUvtD,EAAhB,cAEKutD,GAAYA,EAAjB,UAEIA,EAAA,QAAJ,kBACEA,EAAA,8BAGF93D,OAAA,aAAoB83D,EAAA,QAApB,YAGF,IAAIG,GAAJ,EAEA,SAASC,EAAT,GACOD,GAAmB1tD,EAAA,UAAc,OAAd,OAAgCA,EAAA,UAAc,OAAtE,QACE0tD,GAAA,EACAJ,EAAA,IAIJ,SAASM,EAAT,GACEF,GAAA,EACAF,EAAA,GAGF,SAASK,EAAT,IACE,IAAIH,IACFA,GAAA,EACAF,EAAA,IAIJ,SAASM,EAAT,OACE,IAAMC,EAAUV,EAAgB/gB,EAAhC,OACA,GACE0gB,EAAA,QAEFj+B,EAAA,QAAaA,EAAA,SAAb,GACAA,EAAA,kBACA,IAAMnyB,EAAQ0vC,EAAA,OAAd,GACI1vC,EAAJ,SACEmyB,EAAA,qBAEEnyB,EAAJ,QACEmyB,EAAA,cAAmBud,EAAA,MAAnB,OAEE1vC,EAAJ,SACEmyB,EAAA,eAAoBnyB,EAApB,QAEEmxD,IAAJ,GACEh/B,EAAA,gCAA8C,CAAE7P,SAAS,IACzD6P,EAAA,8BAA4C,CAAE7P,SAAS,IACvD6P,EAAA,+BAAmD,CAAE7P,SAAS,IAC9D6P,EAAA,kCAEAA,EAAA,gCACAA,EAAA,8BACAA,EAAA,iCAEAA,EAAA,8BACAA,EAAA,4BAEAA,EAAA,wBAb0B,GAgB1BA,EAAA,+BAA6C,CAAE7P,SAAS,MAC9C6uC,GAAL,GACLC,EAAA,GAIJ,SAASA,EAAT,GACEj/B,EAAA,mCACAA,EAAA,oCACAA,EAAA,kCACAA,EAAA,mCACAA,EAAA,qCACAA,EAAA,iCACAA,EAAA,oCACAA,EAAA,iCACAA,EAAA,+BACAA,EAAA,mCACAA,EAAA,8BAGF,SAASsd,EAAT,OACEyhB,EAAa/+B,EAAIud,GAAjB,GAcF,SAASqB,EAAT,UACS5e,EAAP,QACAi/B,EAAA,GAGF,SAASt4C,EAAT,KACE,GAAI42B,EAAA,QAAkBA,EAAtB,UAIA,IAAM2hB,EAAaZ,EAAgB/gB,EAAnC,UACAwhB,EAAa/+B,EAAIud,EAAjB,IAGK,IAAM4hB,EAAS,CACpBn5D,KADoB,EAEpB44C,SACAj4B,UAGF,ICtVe,gBAAW,CACxBhf,KADwB,WAGxBwkB,WAAY,CACVgzC,OAAA,GAGFrzD,MAAO,CACL6vC,YADK,OAELyjB,OAFK,QAGL1tD,SAHK,QAIL2tD,MAAO,CACLlzD,KADK,QAELC,aAASpI,GAEXs7D,iBARK,OASLC,KATK,QAULzZ,KAAM,CAACniD,OAVF,QAWLqd,GAAI,CAACrd,OAXA,QAYL67D,KAZK,QAaLl1D,QAbK,QAcLm1D,OAAQ,CACNtzD,KAAM,CAACgG,QADD,QAEN/F,QAAS,MAEXkB,IAlBK,OAmBLzI,OAAQlB,QAGVwG,KAAM,iBAAO,CACXq/C,UADW,EAEXkW,WAAY,KAGd1tD,SAAU,CACRi2C,QADQ,WAEN,IAAMA,EAAN,GAEA,OAAI/iD,KAAJ,KAEIA,KAAJ,cAAsB+iD,EAAQ/iD,KAAR,aAA4BA,KAA5B,UAClBA,KAAJ,aAAqB+iD,EAAQ/iD,KAAR,YAA2BA,KAA3B,WAHD+iD,GAOtB0X,eAXQ,WAWM,MACZ,gBAAOz6D,KAAP,WAAwBA,KAAD,UAAkBA,KAAzC,aAEF06D,YAdQ,WAeN,OAAI16D,KAAJ,UAEOiN,QACLjN,KAAK26D,QACL36D,KAAKw7B,WADL,OAEAx7B,KAAKw7B,WAFL,WAGAx7B,KAAKu7B,OAJP,WAOFo/B,OAxBQ,WAyBN,OAAO36D,KAAK8b,IAAM9b,KAAX,MAAwBA,KAA/B,MAEFmW,OAAQ,sBAGVyJ,MAAO,CACLg7C,OAAQ,iBAGVxtD,QAAS,CACPD,MADO,SACF,GACHnN,KAAA,kBAEF66D,kBAJO,WAIU,MAEf,EADIV,EAAQn6D,KAAZ,MAGMiF,GAAI,GACRiJ,MAAO,CACL4sD,SAAU,aAAc96D,KAAd,OAA4BA,KAAKu7B,OAAjC,cAAmDz8B,GAE/DgK,MAAO9I,KAJe,QAKtBwO,MAAOxO,KALe,OAMtB4G,MANsB,GAOtBqgB,WAAY,CAAC,CACXxkB,KADW,SAEXkG,MAAO3I,KAAKy6D,kBATN,iBAWPz6D,KAAK8b,GAAK,WAAX,KAXQ,iCAYH9b,KAD0B,YAXvB,IAaNmN,MAAOnN,KAAKmN,SAbN,uBAeH,QAfG,GAuBV,GALA,qBAAWnN,KAAP,QACFm6D,EAAoB,MAAZn6D,KAAK8b,IACV9b,KAAK8b,KAAOra,OAAOzB,KAAnB,KADH,MACkCA,KAAK8b,GAAG6C,MAGxC3e,KAAJ,GAAa,CAGX,IAAIy2C,EAAcz2C,KAAlB,YACIo6D,EAAmBp6D,KAAKo6D,kBAA5B,EAEIp6D,KAAJ,aACEy2C,EAAc,UAAGA,EAAH,YAAkBz2C,KAAlB,YAAd,OACAo6D,EAAmB,UAAGA,EAAH,YAAuBp6D,KAAvB,YAAnB,QAGFoI,EAAMpI,KAAKs6D,KAAO,YAAlB,cACA74D,OAAA,OAAcwD,EAAd,MAA0B,CACxB6W,GAAI9b,KADoB,GAExBm6D,QACA1jB,cACA2jB,mBACAF,OAAQl6D,KALgB,OAMxBoF,QAASpF,KAAKoF,eAGhBgD,GAAOpI,KAAK4gD,KAAN,IAAsB5gD,KAAtB,MAAN,MAEI,MAAAoI,GAAepI,KAAnB,OAA8BiF,EAAA,WAAmBjF,KAAnB,MAKhC,OAFIA,KAAJ,SAAiBiF,EAAA,aAAqBjF,KAArB,QAEV,CAAEoI,MAAKnD,SAEhB81D,cA7DO,WA6DM,WACX,GAAK/6D,KAAD,IAAaA,KAAK65B,MAAlB,MAAiC75B,KAArC,QACA,IAAMy2C,EAAc,UAAGz2C,KAAKy2C,YAAR,YAAuBz2C,KAAKw6D,YAA5B,IAApB,OAEM77C,EAAO,qBAAH,OAAV,GAEA3e,KAAA,WAAe,WAET,eAAqB,QAAD,KAAxB,IACE,gBAINm4D,OAAQ,gB,wBC5HNrT,EAAa,OAAAx9B,EAAA,MAAO,EAAD,gBAKvB,EALuB,aAMvB,eAAkB,eAOL,OAAAw9B,EAAA,gBAAoC,CACjDriD,KADiD,QAGjDmE,MAAO,CACL6vC,YAAa,CACXxvC,KADW,OAEXC,QAFW,WAGT,OAAKlH,KAAL,UAEOA,KAAKg7D,UAAZ,YAF4B,KAKhCC,MATK,QAULC,UAVK,QAWLC,IAXK,QAYL9uD,KAZK,QAaLurB,QAbK,QAcLwjC,SAdK,QAeLC,MAfK,QAgBLC,mBAhBK,QAiBLC,QAjBK,QAkBLnzD,IAAK,CACHnB,KADG,OAEHC,QAAS,UAEXsG,KAtBK,QAuBLguD,KAvBK,QAwBLv0D,KAAM,CACJA,KADI,OAEJC,QAAS,UAEXyB,MAAO,MAGT1D,KAAM,iBAAO,CACXu1D,WAAY,kBAGd1tD,SAAU,CACRi2C,QADQ,WAEN,mFACE,SADK,GAEF,gCAFE,OAAP,IAGE,kBAAmB/iD,KAHd,SAIL,eAAgBA,KAJX,MAKL,gBAAiBA,KALZ,OAML,kBAAmBA,KANd,SAOL,qBAAsBA,KAPjB,WAQL,aAAcA,KART,IASL,eAAgBA,KATX,MAUL,gBAAiBA,KAVZ,MAWL,cAAeA,KAXV,KAYL,cAAeA,KAZV,KAaL,iBAAkBA,KAbb,QAcL,kBAAmBA,KAdd,SAeL,eAAgBA,KAfX,MAgBL,eAAgBA,KAhBX,MAiBL,eAAgBA,KAjBX,QAkBL,iBAAkBA,KAlBb,QAmBL,gBAAiBA,KAnBZ,GAoBL,cAAeA,KApBV,KAqBL,cAAeA,KArBV,KAsBL,aAAcA,KAtBT,KAuBFA,KAvBE,cAwBFA,KAxBE,cAyBFA,KAzBE,kBA0BFA,KAAKy7D,kBAGZC,kBA/BQ,WAgCN,IAAI17D,KAAJ,SAEA,OAAO,+CAAP,OAEFy6D,eApCQ,WAoCM,MACNkB,GAAgB37D,KAAKqM,OAAQrM,KAAb,KAAwB,CAAE47D,QAAQ,GACxD,OAAI57D,KAAJ,WACK,SAAOA,KAAP,cAEP67D,MAzCQ,WA0CN,OAAQ77D,KAAD,OAAeA,KAAf,QAA8BA,KAA9B,WAAgDA,KAAvD,MAEF87D,WA5CQ,WA6CN,OAAO7uD,SACJjN,KAAD,OACCA,KADD,OAECA,KAFD,WAGCA,KAHD,YAICA,KAJD,WAKCA,KALD,QAMmB,MAAlBA,KAAK+7D,WAAqBnvD,OAAO5M,KAAP,WAP7B,KAUFg8D,QAvDQ,WAwDN,OAAO/uD,QACLjN,KAAKqM,MACLrM,KAFF,MAKFmW,OA7DQ,WA8DN,yBACKnW,KAAKkW,oBAKdktB,QA1GiD,WA0G1C,WACC4f,EAAgB,CACpB,CAAC,OADmB,QAEpB,CAAC,UAFmB,YAGpB,CAAC,QAHH,YAOAA,EAAA,SAAsB,YAA4B,0BAA3B,EAA2B,KAA5B,EAA4B,KAC5C,wBAAJ,IAA0C,eAASr/B,EAAU/d,EAAnB,OAI9CwH,QAAS,CACPD,MADO,SACF,IAEFnN,KAAD,qBAA6BA,KAA7B,KAAyC+L,EAAzC,QAAqD/L,KAAKq6B,IAA1D,OACAr6B,KAAA,iBAEAA,KAAA,WAAkBA,KAAlB,UAEFqjD,WARO,WASL,OAAOrjD,KAAK8uB,eAAe,OAAQ,CACjCjmB,YAAa,kBACZ7I,KAAKuN,OAFR,UAIF0uD,UAbO,WAcL,OAAOj8D,KAAK8uB,eAAe,OAAQ,CACjChmB,MAAO,iBACN9I,KAAKuN,OAAO2uD,QAAU,CAACl8D,KAAK8uB,eAAe,EAAmB,CAC/DloB,MAAO,CACL4vD,eADK,EAEL7pD,KAFK,GAGL+B,MAAO,SAMfnG,OAjJiD,SAiJ3C,GACJ,IAAMC,EAAW,CACfxI,KADe,aAEfA,KAAK43B,SAAW53B,KAFlB,aAIA,EAAsBA,KAAtB,oBAAM,EAAN,EAAM,IAAOiF,EAAb,EAAaA,KACPk3D,EAAWn8D,KAAK67D,MAClB77D,KADa,mBAEbA,KAFJ,aAYA,MARA,WAAIoI,IACFnD,EAAA,WAAmBjF,KAAnB,KACAiF,EAAA,eAAuBjF,KAAvB,UAEFiF,EAAA,YAAoB,CAAC,SAAU,UAAUqR,SAAS,OAA9B,OAA8B,CAAOtW,KAArC,QAChBA,KADgB,MAEhBmV,KAAA,UAAenV,KAFnB,OAIO4I,EAAER,EAAKpI,KAAKwM,SAAWvH,EAAOk3D,EAASn8D,KAAD,MAArC,GAAR,O,uBC1MJ,IAAIoG,EAAQ,EAAQ,QAGpB7H,EAAOC,SAAW4H,GAAM,WAEtB,OAA8E,GAAvE3E,OAAO6E,eAAe,GAAI,EAAG,CAAEC,IAAK,WAAc,OAAO,KAAQ,O,kCCJ1E,IAAIzD,EAAc,EAAQ,QACtBkU,EAAuB,EAAQ,QAC/BnU,EAA2B,EAAQ,QAEvCtE,EAAOC,QAAU,SAAU6S,EAAQrD,EAAKrF,GACtC,IAAIyzD,EAAct5D,EAAYkL,GAC1BouD,KAAe/qD,EAAQ2F,EAAqB3V,EAAEgQ,EAAQ+qD,EAAav5D,EAAyB,EAAG8F,IAC9F0I,EAAO+qD,GAAezzD,I,uBCR7B,IAAII,EAAyB,EAAQ,QAEjCszD,EAAO,KAIX99D,EAAOC,QAAU,SAAU+L,EAAQnC,EAAKk0D,EAAW3zD,GACjD,IAAIgD,EAAIlN,OAAOsK,EAAuBwB,IAClCgyD,EAAK,IAAMn0D,EAEf,MADkB,KAAdk0D,IAAkBC,GAAM,IAAMD,EAAY,KAAO79D,OAAOkK,GAAOvD,QAAQi3D,EAAM,UAAY,KACtFE,EAAK,IAAM5wD,EAAI,KAAOvD,EAAM,M,qBCVrC7J,EAAOC,QAAU,SAAUoD,GACzB,MAAqB,kBAAPA,EAAyB,OAAPA,EAA4B,oBAAPA,I,8CCDvD,IAAI+oD,EAAQ,EAAQ,QAEhB6R,EAAmB57D,SAASU,SAGE,mBAAvBqpD,EAAMkF,gBACflF,EAAMkF,cAAgB,SAAUjuD,GAC9B,OAAO46D,EAAiBz9D,KAAK6C,KAIjCrD,EAAOC,QAAUmsD,EAAMkF,e,oCCVvB,IAAIxwD,EAAI,EAAQ,QACZ6D,EAA2B,EAAQ,QAAmD7B,EACtF7B,EAAW,EAAQ,QACnB4W,EAAa,EAAQ,QACrBrN,EAAyB,EAAQ,QACjCsN,EAAuB,EAAQ,QAC/BwmC,EAAU,EAAQ,QAGlB4f,EAAY,GAAGC,SACf5yD,EAAM3E,KAAK2E,IAEXkzC,EAA0B3mC,EAAqB,YAE/C4mC,GAAoBJ,IAAYG,KAA6B,WAC/D,IAAIzpC,EAAarQ,EAAyBzE,OAAOyC,UAAW,YAC5D,OAAOqS,IAAeA,EAAWiL,SAF8B,GAOjEnf,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,QAASusC,IAAqBD,GAA2B,CAC1F0f,SAAU,SAAkBnmD,GAC1B,IAAI3X,EAAOH,OAAOsK,EAAuB/I,OACzCoW,EAAWG,GACX,IAAIomD,EAAcv9D,UAAUP,OAAS,EAAIO,UAAU,QAAKN,EACpDkD,EAAMxC,EAASZ,EAAKC,QACpBmsC,OAAsBlsC,IAAhB69D,EAA4B36D,EAAM8H,EAAItK,EAASm9D,GAAc36D,GACnEk7C,EAASz+C,OAAO8X,GACpB,OAAOkmD,EACHA,EAAU19D,KAAKH,EAAMs+C,EAAQlS,GAC7BpsC,EAAKwB,MAAM4qC,EAAMkS,EAAOr+C,OAAQmsC,KAASkS,M,oCC/BjD,IAAI/2C,EAAS,EAAQ,QAAiCA,OAItD5H,EAAOC,QAAU,SAAUmN,EAAGN,EAAON,GACnC,OAAOM,GAASN,EAAU5E,EAAOwF,EAAGN,GAAOxM,OAAS,K,sFCLtD,oFAGM+9D,EAAoB,CACxB,CAAC,QAAD,QADwB,OAExB,eAFwB,OAGxB,CAAC,OAAD,KAHF,QAOMC,EAAwB,SAAAt8D,GAAD,OAC3BA,GAAA,eACIA,EACA,MAAQ,KAAR,IAAQA,EAAM,EAAd,KAHN,MAOMu8D,EAAoB,CACxB,CAAC,MAAQ,MADe,OAExB,CAAC,MAAQ,MAFe,OAGxB,CAAC,MAAQ,MAHX,QAOMC,EAAwB,SAAAx8D,GAAD,OAC3BA,GAAA,OACIA,EADJ,gBAEMA,EAAD,MAAD,MAHN,MAMM,cAMJ,IALA,IAAMqxD,EAAM1vD,MAAZ,GACM85C,EAAN,EACMghB,EAHyB,EAMtBr8D,EAAT,EAAgBA,EAAhB,MACEixD,EAAA,GAASzsD,KAAA,MAAT,IAAoB,eAAM62C,EACxBghB,EAAA,MAAeC,EAAf,GACAD,EAAA,MAAeC,EADf,GAEAD,EAAA,MAAeC,EAHG,MAQtB,OAAQrL,EAAA,IAAD,KAAkBA,EAAA,IAAlB,IAAkCA,EAAA,IAAzC,GAGI,cAWJ,IAVA,IAAMqL,EAAW,CAAC,EAAG,EAArB,GACMjhB,EAAN,EACMghB,EAH4B,EAM5BxF,EAAIxb,GAAW4V,GAAA,GAAD,KAApB,KACMsL,EAAIlhB,GAAW4V,GAAA,EAAD,KAApB,KACM3yD,EAAI+8C,GAAW4V,GAAA,EAAD,KARc,KAWzBjxD,EAAT,EAAgBA,EAAhB,MACEs8D,EAAA,GAASD,EAAA,QAAmBA,EAAA,MAAnB,EAAsCA,EAAA,MAA/C,EAGF,W,oLC7Da,gBAAW,CACxBv6D,KADwB,YAGxBmE,MAAO,CACL20D,QAAS,CAACtuD,QADL,QAELuuD,KAAMvuD,SAGRH,SAAU,CACRqwD,eADQ,WAEN,IAAMC,EAAN,GACM7B,EAAU,kBAAOv7D,KAAP,QACZvB,OAAOuB,KADK,UAAhB,IAEIA,KAAKu7D,QAET,GAAIv7D,KAAJ,KACEo9D,EAAA,uBACK,qBAAW7B,EAAsB,CACtC,IADsC,EAChCl4D,EAASk4D,EAAA,MAAf,KADsC,iBAGtC,GAHsC,IAGtC,2BAA4B,KAA5B,EAA4B,QAC1B6B,EAAA,4BAJoC,oCAM7B7B,GACT6B,EAAA,gBAGF,OAAOA,EAAA,2BACJA,EAAA,KAAD,MAAuB,GADzB,O,wBCZS,cAAA91C,EAAA,MAAO,EAAD,4BAAN,eAON,CACP7kB,KADO,UAGPmE,MAAO,CACLw0D,SADK,QAELiC,OAFK,QAGLj1D,IAAK,CACHnB,KADG,OAEHC,QAAS,QAIb4F,SAAU,CACRi2C,QADQ,WAEN,qDACE,WADK,EAEL,oBAAqB/iD,KAFhB,SAGL,kBAAmBA,KAHd,QAIFA,KAJE,cAKFA,KALE,kBAMFA,KAAKm9D,iBAGZhnD,OAXQ,WAYN,OAAOnW,KAAP,mBAIJuI,OA5BO,SA4BD,GACJ,IAAMtD,EAAO,CACX6D,MAAO9I,KADI,QAEXwO,MAAOxO,KAFI,OAGXoO,GAAIpO,KAAKkN,YAGX,OAAOtE,EACL5I,KADM,IAENA,KAAKujD,mBAAmBvjD,KAAxB,MAFM,GAGNA,KAAKuN,OAHP,a,oCC1DJ,IAAI0jD,EAAS,EAAQ,QAQrB,SAASqM,EAAYC,GACnB,GAAwB,oBAAbA,EACT,MAAM,IAAI1tD,UAAU,gCAGtB,IAAI2tD,EACJx9D,KAAKsE,QAAU,IAAIC,SAAQ,SAAyBC,GAClDg5D,EAAiBh5D,KAGnB,IAAIi5D,EAAQz9D,KACZu9D,GAAS,SAAgB5e,GACnB8e,EAAMllC,SAKVklC,EAAMllC,OAAS,IAAI04B,EAAOtS,GAC1B6e,EAAeC,EAAMllC,YAOzB+kC,EAAYp8D,UAAUkoD,iBAAmB,WACvC,GAAIppD,KAAKu4B,OACP,MAAMv4B,KAAKu4B,QAQf+kC,EAAYlyD,OAAS,WACnB,IAAIsyD,EACAD,EAAQ,IAAIH,GAAY,SAAkBp+D,GAC5Cw+D,EAASx+D,KAEX,MAAO,CACLu+D,MAAOA,EACPC,OAAQA,IAIZn/D,EAAOC,QAAU8+D,G,uFCxCjB,SAAS15C,EAAT,KACE,IAAMypB,EAAYgL,EAAA,WAAlB,GACM1vC,EAAQ0vC,EAAd,MACA,EAA6B,+BAEzB,CAAElvB,QAAF,EAAkB/W,QAAS,IAFzB,EAAN,EAAM,QAAWA,EAAjB,EAAiBA,QAGX6X,EAAW,IAAI0zC,sBAAqB,WAGtC,IAFFtO,EAEE,uDAHsC,KAGtC,uCAEF,GAAKv0B,EAAL,UAIA,GACE3R,KACGkkB,EAAD,OACAvS,EAAA,SAHJ,MAKE,CACA,IAAM8iC,EAAiB3wD,QAAQoiD,EAAA,MAAa,SAAAhC,GAAK,OAAIA,EAArD,mBAEAlkC,EAAQkmC,EAASplC,EAAjB,GAKE6Q,EAAA,eAAoBuS,EAAxB,KAAwCqM,EAAxC,GAEM5e,EAAA,eAAD,KAxBP,GA2BAA,EAAA,SAAc,CAAEzH,MAAF,EAAepJ,YAE7BA,EAAAtF,QAAA,GAGF,SAAS+0B,EAAT,GAEO5e,EAAL,WAEAA,EAAA,4BAAAA,UACOA,EAAP,UAGK,IAAM+iC,EAAY,CACvBj6C,WACA81B,UAGF,U,qBCnEA,IAAIz4B,EAAK,EACL68C,EAAU34D,KAAK44D,SAEnBx/D,EAAOC,QAAU,SAAUwP,GACzB,MAAO,UAAYvP,YAAeK,IAARkP,EAAoB,GAAKA,GAAO,QAAUiT,EAAK68C,GAASx8D,SAAS,M,qBCJ7F,IAAIqB,EAAc,EAAQ,QACtBqU,EAAuB,EAAQ,QAC/BnU,EAA2B,EAAQ,QAEvCtE,EAAOC,QAAUmE,EAAc,SAAU0O,EAAQrD,EAAKrF,GACpD,OAAOqO,EAAqB3V,EAAEgQ,EAAQrD,EAAKnL,EAAyB,EAAG8F,KACrE,SAAU0I,EAAQrD,EAAKrF,GAEzB,OADA0I,EAAOrD,GAAOrF,EACP0I,I,kCCLT,IAAI2sD,EAAc,EAAQ,QACtBr0D,EAAgB,EAAQ,QACxBokD,EAAS,EAAQ,QAEjBkQ,EAAa9yD,OAAOjK,UAAU0O,KAC9B65C,EAAgBsE,EAAO,wBAAyBtvD,OAAOyC,UAAUkE,SAEjE84D,EAAcD,EAEdE,EAA2B,WAC7B,IAAIC,EAAM,IACNC,EAAM,MAGV,OAFAJ,EAAWl/D,KAAKq/D,EAAK,KACrBH,EAAWl/D,KAAKs/D,EAAK,KACI,IAAlBD,EAAI3zD,WAAqC,IAAlB4zD,EAAI5zD,UALL,GAQ3Bb,EAAgBD,EAAcC,eAAiBD,EAAc20D,aAG7DC,OAAuCz/D,IAAvB,OAAO8Q,KAAK,IAAI,GAEhC4uD,EAAQL,GAA4BI,GAAiB30D,EAErD40D,IACFN,EAAc,SAAc14D,GAC1B,IACIiF,EAAWg0D,EAAQz4D,EAAOrF,EAD1B+9D,EAAK1+D,KAELgL,EAASpB,GAAiB80D,EAAG1zD,OAC7BJ,EAAQozD,EAAYj/D,KAAK2/D,GACzBtzD,EAASszD,EAAGtzD,OACZuzD,EAAa,EACbC,EAAUp5D,EA+Cd,OA7CIwF,IACFJ,EAAQA,EAAMxF,QAAQ,IAAK,KACC,IAAxBwF,EAAM4L,QAAQ,OAChB5L,GAAS,KAGXg0D,EAAUngE,OAAO+G,GAAKpF,MAAMs+D,EAAGj0D,WAE3Bi0D,EAAGj0D,UAAY,KAAOi0D,EAAG5zD,WAAa4zD,EAAG5zD,WAAuC,OAA1BtF,EAAIk5D,EAAGj0D,UAAY,MAC3EW,EAAS,OAASA,EAAS,IAC3BwzD,EAAU,IAAMA,EAChBD,KAIFF,EAAS,IAAItzD,OAAO,OAASC,EAAS,IAAKR,IAGzC2zD,IACFE,EAAS,IAAItzD,OAAO,IAAMC,EAAS,WAAYR,IAE7CuzD,IAA0B1zD,EAAYi0D,EAAGj0D,WAE7CzE,EAAQi4D,EAAWl/D,KAAKiM,EAASyzD,EAASC,EAAIE,GAE1C5zD,EACEhF,GACFA,EAAM64D,MAAQ74D,EAAM64D,MAAMz+D,MAAMu+D,GAChC34D,EAAM,GAAKA,EAAM,GAAG5F,MAAMu+D,GAC1B34D,EAAMqF,MAAQqzD,EAAGj0D,UACjBi0D,EAAGj0D,WAAazE,EAAM,GAAGnH,QACpB6/D,EAAGj0D,UAAY,EACb0zD,GAA4Bn4D,IACrC04D,EAAGj0D,UAAYi0D,EAAG5uD,OAAS9J,EAAMqF,MAAQrF,EAAM,GAAGnH,OAAS4L,GAEzD8zD,GAAiBv4D,GAASA,EAAMnH,OAAS,GAG3C4qD,EAAc1qD,KAAKiH,EAAM,GAAIy4D,GAAQ,WACnC,IAAK99D,EAAI,EAAGA,EAAIvB,UAAUP,OAAS,EAAG8B,SACf7B,IAAjBM,UAAUuB,KAAkBqF,EAAMrF,QAAK7B,MAK1CkH,IAIXzH,EAAOC,QAAU0/D,G,uBCtFjB,IAAI93D,EAAQ,EAAQ,QAEhBR,EAAc,kBAEduN,EAAW,SAAU2rD,EAASC,GAChC,IAAIp2D,EAAQ1D,EAAK0sC,EAAUmtB,IAC3B,OAAOn2D,GAASq2D,GACZr2D,GAASs2D,IACW,mBAAbF,EAA0B34D,EAAM24D,KACrCA,IAGJptB,EAAYx+B,EAASw+B,UAAY,SAAUpnC,GAC7C,OAAO9L,OAAO8L,GAAQnF,QAAQQ,EAAa,KAAKxB,eAG9Ca,EAAOkO,EAASlO,KAAO,GACvBg6D,EAAS9rD,EAAS8rD,OAAS,IAC3BD,EAAW7rD,EAAS6rD,SAAW,IAEnCzgE,EAAOC,QAAU2U,G,2DCnBjB,IAAI9T,EAAI,EAAQ,QACZmR,EAAa,EAAQ,QACrBC,EAAyB,EAAQ,QAIrCpR,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,OAAQD,EAAuB,SAAW,CAC3E4pD,KAAM,SAAcn2D,GAClB,OAAOsM,EAAWxQ,KAAM,IAAK,OAAQkE,O,oCCRzC,IAAI7E,EAAI,EAAQ,QACZ+G,EAAQ,EAAQ,QAChB0T,EAAU,EAAQ,QAClB3Z,EAAW,EAAQ,QACnBZ,EAAW,EAAQ,QACnBC,EAAW,EAAQ,QACnB6oD,EAAiB,EAAQ,QACzB3oD,EAAqB,EAAQ,QAC7BwoD,EAA+B,EAAQ,QACvC9pD,EAAkB,EAAQ,QAC1BoT,EAAa,EAAQ,QAErB0tD,EAAuB9gE,EAAgB,sBACvC+gE,EAAmB,iBACnBC,EAAiC,iCAKjCC,EAA+B7tD,GAAc,KAAOpL,GAAM,WAC5D,IAAIuL,EAAQ,GAEZ,OADAA,EAAMutD,IAAwB,EACvBvtD,EAAM1Q,SAAS,KAAO0Q,KAG3B2tD,EAAkBpX,EAA6B,UAE/CqX,EAAqB,SAAUx/D,GACjC,IAAKI,EAASJ,GAAI,OAAO,EACzB,IAAIy/D,EAAaz/D,EAAEm/D,GACnB,YAAsBpgE,IAAf0gE,IAA6BA,EAAa1lD,EAAQ/Z,IAGvDqT,GAAUisD,IAAiCC,EAK/CjgE,EAAE,CAAEM,OAAQ,QAASC,OAAO,EAAM8Q,OAAQ0C,GAAU,CAElDnS,OAAQ,SAAgB+rC,GACtB,IAGIrsC,EAAG8+D,EAAG5gE,EAAQmD,EAAK09D,EAHnB3/D,EAAIR,EAASS,MACbE,EAAIR,EAAmBK,EAAG,GAC1BwC,EAAI,EAER,IAAK5B,GAAK,EAAG9B,EAASO,UAAUP,OAAQ8B,EAAI9B,EAAQ8B,IAElD,GADA++D,GAAW,IAAP/+D,EAAWZ,EAAIX,UAAUuB,GACzB4+D,EAAmBG,GAAI,CAEzB,GADA19D,EAAMxC,EAASkgE,EAAE7gE,QACb0D,EAAIP,EAAMm9D,EAAkB,MAAMtvD,UAAUuvD,GAChD,IAAKK,EAAI,EAAGA,EAAIz9D,EAAKy9D,IAAKl9D,IAASk9D,KAAKC,GAAGrX,EAAenoD,EAAGqC,EAAGm9D,EAAED,QAC7D,CACL,GAAIl9D,GAAK48D,EAAkB,MAAMtvD,UAAUuvD,GAC3C/W,EAAenoD,EAAGqC,IAAKm9D,GAI3B,OADAx/D,EAAErB,OAAS0D,EACJrC,M,uBC1DX,IAAIoJ,EAAW,EAAQ,QACnByI,EAAgB,EAAQ,QAG5BxT,EAAOC,QAAU,SAAU6T,EAAU1T,EAAIgK,EAAOurD,GAC9C,IACE,OAAOA,EAAUv1D,EAAG2K,EAASX,GAAO,GAAIA,EAAM,IAAMhK,EAAGgK,GAEvD,MAAO9G,GAEP,MADAkQ,EAAcM,GACRxQ,K,uBCVV,IAAIc,EAAc,EAAQ,QACtBK,EAAiB,EAAQ,QACzBsG,EAAW,EAAQ,QACnBxG,EAAc,EAAQ,QAGtB68D,EAAkBl+D,OAAO6E,eAI7B9H,EAAQ6C,EAAIsB,EAAcg9D,EAAkB,SAAwB5/D,EAAGoD,EAAGy8D,GAIxE,GAHAt2D,EAASvJ,GACToD,EAAIL,EAAYK,GAAG,GACnBmG,EAASs2D,GACL58D,EAAgB,IAClB,OAAO28D,EAAgB5/D,EAAGoD,EAAGy8D,GAC7B,MAAO/9D,IACT,GAAI,QAAS+9D,GAAc,QAASA,EAAY,MAAM/vD,UAAU,2BAEhE,MADI,UAAW+vD,IAAY7/D,EAAEoD,GAAKy8D,EAAWj3D,OACtC5I,I,oCClBT,IAAI+zD,EAAoB,EAAQ,QAA+BA,kBAC3D15C,EAAS,EAAQ,QACjBvX,EAA2B,EAAQ,QACnC+rD,EAAiB,EAAQ,QACzBlP,EAAY,EAAQ,QAEpByU,EAAa,WAAc,OAAOn0D,MAEtCzB,EAAOC,QAAU,SAAU61D,EAAqB9D,EAAMr/C,GACpD,IAAI7S,EAAgBkyD,EAAO,YAI3B,OAHA8D,EAAoBnzD,UAAYkZ,EAAO05C,EAAmB,CAAE5iD,KAAMrO,EAAyB,EAAGqO,KAC9F09C,EAAeyF,EAAqBh2D,GAAe,GAAO,GAC1DqhD,EAAUrhD,GAAiB81D,EACpBE,I,oCCZT,IAAIjuD,EAAQ,EAAQ,QAIpB,SAASy5D,EAAGvqB,EAAGj0C,GACb,OAAO8J,OAAOmqC,EAAGj0C,GAGnB7C,EAAQoL,cAAgBxD,GAAM,WAE5B,IAAIs4D,EAAKmB,EAAG,IAAK,KAEjB,OADAnB,EAAGj0D,UAAY,EACW,MAAnBi0D,EAAG9uD,KAAK,WAGjBpR,EAAQ8/D,aAAel4D,GAAM,WAE3B,IAAIs4D,EAAKmB,EAAG,KAAM,MAElB,OADAnB,EAAGj0D,UAAY,EACU,MAAlBi0D,EAAG9uD,KAAK,W,kCCpBjB,IAAIvQ,EAAI,EAAQ,QACZgsD,EAAgB,EAAQ,QACxBlqD,EAAkB,EAAQ,QAC1BkP,EAAsB,EAAQ,QAE9ByvD,EAAa,GAAGj/D,KAEhBk/D,EAAc1U,GAAiB5pD,OAC/B6O,EAAgBD,EAAoB,OAAQ,KAIhDhR,EAAE,CAAEM,OAAQ,QAASC,OAAO,EAAM8Q,OAAQqvD,IAAgBzvD,GAAiB,CACzEzP,KAAM,SAAcwJ,GAClB,OAAOy1D,EAAW/gE,KAAKoC,EAAgBnB,WAAqBlB,IAAduL,EAA0B,IAAMA,O,kCCdlF,IAAIyP,EAAU,EAAQ,QAClBta,EAAW,EAAQ,QACnBsB,EAAO,EAAQ,QAIfxB,EAAmB,SAAUK,EAAQgkB,EAAUvY,EAAQnL,EAAW0b,EAAOqkD,EAAOC,EAAQ1uD,GAC1F,IAGI+nD,EAHA4G,EAAcvkD,EACdwkD,EAAc,EACdC,IAAQH,GAASn/D,EAAKm/D,EAAQ1uD,EAAS,GAG3C,MAAO4uD,EAAclgE,EAAW,CAC9B,GAAIkgE,KAAe/0D,EAAQ,CAGzB,GAFAkuD,EAAU8G,EAAQA,EAAMh1D,EAAO+0D,GAAcA,EAAax8C,GAAYvY,EAAO+0D,GAEzEH,EAAQ,GAAKlmD,EAAQw/C,GACvB4G,EAAc5gE,EAAiBK,EAAQgkB,EAAU21C,EAAS95D,EAAS85D,EAAQz6D,QAASqhE,EAAaF,EAAQ,GAAK,MACzG,CACL,GAAIE,GAAe,iBAAkB,MAAMrwD,UAAU,sCACrDlQ,EAAOugE,GAAe5G,EAGxB4G,IAEFC,IAEF,OAAOD,GAGT3hE,EAAOC,QAAUc,G,qBC/BjB,IAAIgS,EAAY,EAAQ,QAExB/S,EAAOC,QAAU,qBAAqBF,KAAKgT,I,kCCD3C,IAAIjS,EAAI,EAAQ,QACZyQ,EAAS,EAAQ,QACjBe,EAAa,EAAQ,QACrBgsC,EAAU,EAAQ,QAClBl6C,EAAc,EAAQ,QACtB09D,EAAgB,EAAQ,QACxBC,EAAoB,EAAQ,QAC5Bl6D,EAAQ,EAAQ,QAChBrD,EAAM,EAAQ,QACd+W,EAAU,EAAQ,QAClB3Z,EAAW,EAAQ,QACnBmJ,EAAW,EAAQ,QACnB/J,EAAW,EAAQ,QACnB4B,EAAkB,EAAQ,QAC1B2B,EAAc,EAAQ,QACtBD,EAA2B,EAAQ,QACnC09D,EAAqB,EAAQ,QAC7B5gB,EAAa,EAAQ,QACrBkL,EAA4B,EAAQ,QACpC2V,EAA8B,EAAQ,QACtC1V,EAA8B,EAAQ,QACtC2V,EAAiC,EAAQ,QACzCzpD,EAAuB,EAAQ,QAC/BpU,EAA6B,EAAQ,QACrCoN,EAA8B,EAAQ,QACtCgD,EAAW,EAAQ,QACnB+6C,EAAS,EAAQ,QACjBC,EAAY,EAAQ,QACpBj6C,EAAa,EAAQ,QACrBgN,EAAM,EAAQ,QACd3iB,EAAkB,EAAQ,QAC1BkyD,EAA+B,EAAQ,QACvCoQ,EAAwB,EAAQ,QAChC9R,EAAiB,EAAQ,QACzB1N,EAAsB,EAAQ,QAC9B9wC,EAAW,EAAQ,QAAgC3L,QAEnDk8D,EAAS3S,EAAU,UACnB4S,EAAS,SACTvO,EAAY,YACZwO,EAAeziE,EAAgB,eAC/BijD,EAAmBH,EAAoBtgC,IACvC0gC,EAAmBJ,EAAoBK,UAAUqf,GACjDE,EAAkBr/D,OAAO4wD,GACzB0O,EAAUjxD,EAAO0Q,OACjBwgD,EAAanwD,EAAW,OAAQ,aAChCowD,EAAiCR,EAA+Bp/D,EAChE6/D,EAAuBlqD,EAAqB3V,EAC5C8/D,EAA4BX,EAA4Bn/D,EACxD+/D,EAA6Bx+D,EAA2BvB,EACxDggE,EAAatT,EAAO,WACpBuT,EAAyBvT,EAAO,cAChCwT,GAAyBxT,EAAO,6BAChCyT,GAAyBzT,EAAO,6BAChC0T,GAAwB1T,EAAO,OAC/B2T,GAAU5xD,EAAO4xD,QAEjBC,IAAcD,KAAYA,GAAQrP,KAAeqP,GAAQrP,GAAWuP,UAGpEC,GAAsBl/D,GAAeyD,GAAM,WAC7C,OAES,GAFFm6D,EAAmBW,EAAqB,GAAI,IAAK,CACtD36D,IAAK,WAAc,OAAO26D,EAAqBlhE,KAAM,IAAK,CAAE2I,MAAO,IAAK3J,MACtEA,KACD,SAAUe,EAAGoD,EAAGy8D,GACnB,IAAIkC,EAA4Bb,EAA+BH,EAAiB39D,GAC5E2+D,UAAkChB,EAAgB39D,GACtD+9D,EAAqBnhE,EAAGoD,EAAGy8D,GACvBkC,GAA6B/hE,IAAM+gE,GACrCI,EAAqBJ,EAAiB39D,EAAG2+D,IAEzCZ,EAEAa,GAAO,SAAU35D,EAAK45D,GACxB,IAAI/wC,EAASowC,EAAWj5D,GAAOm4D,EAAmBQ,EAAQ1O,IAO1D,OANAhR,EAAiBpwB,EAAQ,CACvBhqB,KAAM25D,EACNx4D,IAAKA,EACL45D,YAAaA,IAEVr/D,IAAasuB,EAAO+wC,YAAcA,GAChC/wC,GAGLgxC,GAAW3B,EAAoB,SAAU1+D,GAC3C,MAAoB,iBAANA,GACZ,SAAUA,GACZ,OAAOH,OAAOG,aAAem/D,GAG3BpB,GAAkB,SAAwB5/D,EAAGoD,EAAGy8D,GAC9C7/D,IAAM+gE,GAAiBnB,GAAgB2B,EAAwBn+D,EAAGy8D,GACtEt2D,EAASvJ,GACT,IAAIiO,EAAMlL,EAAYK,GAAG,GAEzB,OADAmG,EAASs2D,GACL78D,EAAIs+D,EAAYrzD,IACb4xD,EAAWrhD,YAIVxb,EAAIhD,EAAG4gE,IAAW5gE,EAAE4gE,GAAQ3yD,KAAMjO,EAAE4gE,GAAQ3yD,IAAO,GACvD4xD,EAAaW,EAAmBX,EAAY,CAAErhD,WAAY1b,EAAyB,GAAG,OAJjFE,EAAIhD,EAAG4gE,IAASO,EAAqBnhE,EAAG4gE,EAAQ99D,EAAyB,EAAG,KACjF9C,EAAE4gE,GAAQ3yD,IAAO,GAIV6zD,GAAoB9hE,EAAGiO,EAAK4xD,IAC9BsB,EAAqBnhE,EAAGiO,EAAK4xD,IAGpCsC,GAAoB,SAA0BniE,EAAG6/C,GACnDt2C,EAASvJ,GACT,IAAIoiE,EAAahhE,EAAgBy+C,GAC7BhjC,EAAO+iC,EAAWwiB,GAAYlhE,OAAOmhE,GAAuBD,IAIhE,OAHA/xD,EAASwM,GAAM,SAAU5O,GAClBrL,IAAe0/D,GAAsBtjE,KAAKojE,EAAYn0D,IAAM2xD,GAAgB5/D,EAAGiO,EAAKm0D,EAAWn0D,OAE/FjO,GAGLuiE,GAAU,SAAgBviE,EAAG6/C,GAC/B,YAAsB9gD,IAAf8gD,EAA2B2gB,EAAmBxgE,GAAKmiE,GAAkB3B,EAAmBxgE,GAAI6/C,IAGjGyiB,GAAwB,SAA8BE,GACxD,IAAIp/D,EAAIL,EAAYy/D,GAAG,GACnBhkD,EAAa6iD,EAA2BriE,KAAKiB,KAAMmD,GACvD,QAAInD,OAAS8gE,GAAmB/9D,EAAIs+D,EAAYl+D,KAAOJ,EAAIu+D,EAAwBn+D,QAC5Eob,IAAexb,EAAI/C,KAAMmD,KAAOJ,EAAIs+D,EAAYl+D,IAAMJ,EAAI/C,KAAM2gE,IAAW3gE,KAAK2gE,GAAQx9D,KAAKob,IAGlGtb,GAA4B,SAAkClD,EAAGoD,GACnE,IAAIvB,EAAKT,EAAgBpB,GACrBiO,EAAMlL,EAAYK,GAAG,GACzB,GAAIvB,IAAOk/D,IAAmB/9D,EAAIs+D,EAAYrzD,IAASjL,EAAIu+D,EAAwBtzD,GAAnF,CACA,IAAIuF,EAAa0tD,EAA+Br/D,EAAIoM,GAIpD,OAHIuF,IAAcxQ,EAAIs+D,EAAYrzD,IAAUjL,EAAInB,EAAI++D,IAAW/+D,EAAG++D,GAAQ3yD,KACxEuF,EAAWgL,YAAa,GAEnBhL,IAGLnS,GAAuB,SAA6BrB,GACtD,IAAIyiE,EAAQrB,EAA0BhgE,EAAgBpB,IAClDkJ,EAAS,GAIb,OAHAmH,EAASoyD,GAAO,SAAUx0D,GACnBjL,EAAIs+D,EAAYrzD,IAASjL,EAAIgR,EAAY/F,IAAM/E,EAAOnE,KAAKkJ,MAE3D/E,GAGLm5D,GAAyB,SAA+BriE,GAC1D,IAAI0iE,EAAsB1iE,IAAM+gE,EAC5B0B,EAAQrB,EAA0BsB,EAAsBnB,EAAyBngE,EAAgBpB,IACjGkJ,EAAS,GAMb,OALAmH,EAASoyD,GAAO,SAAUx0D,IACpBjL,EAAIs+D,EAAYrzD,IAAUy0D,IAAuB1/D,EAAI+9D,EAAiB9yD,IACxE/E,EAAOnE,KAAKu8D,EAAWrzD,OAGpB/E,GAkHT,GA7GKo3D,IACHU,EAAU,WACR,GAAI/gE,gBAAgB+gE,EAAS,MAAMlxD,UAAU,+BAC7C,IAAImyD,EAAe5iE,UAAUP,aAA2BC,IAAjBM,UAAU,GAA+BX,OAAOW,UAAU,SAA7BN,EAChEsJ,EAAM2Y,EAAIihD,GACV58C,EAAS,SAAUzc,GACjB3I,OAAS8gE,GAAiB17C,EAAOrmB,KAAKuiE,EAAwB34D,GAC9D5F,EAAI/C,KAAM2gE,IAAW59D,EAAI/C,KAAK2gE,GAASv4D,KAAMpI,KAAK2gE,GAAQv4D,IAAO,GACrEy5D,GAAoB7hE,KAAMoI,EAAKvF,EAAyB,EAAG8F,KAG7D,OADIhG,GAAeg/D,IAAYE,GAAoBf,EAAiB14D,EAAK,CAAE8O,cAAc,EAAM0J,IAAKwE,IAC7F28C,GAAK35D,EAAK45D,IAGnBhvD,EAAS+tD,EAAQ1O,GAAY,YAAY,WACvC,OAAO/Q,EAAiBthD,MAAMoI,OAGhC4K,EAAS+tD,EAAS,iBAAiB,SAAUiB,GAC3C,OAAOD,GAAKhhD,EAAIihD,GAAcA,MAGhCp/D,EAA2BvB,EAAIghE,GAC/BrrD,EAAqB3V,EAAIs+D,GACzBc,EAA+Bp/D,EAAI4B,GACnC4nD,EAA0BxpD,EAAIm/D,EAA4Bn/D,EAAID,GAC9D0pD,EAA4BzpD,EAAI+gE,GAEhC9R,EAA6BjvD,EAAI,SAAUoB,GACzC,OAAOs/D,GAAK3jE,EAAgBqE,GAAOA,IAGjCE,IAEFu+D,EAAqBH,EAAQ1O,GAAY,cAAe,CACtDn7C,cAAc,EACd3Q,IAAK,WACH,OAAO+6C,EAAiBthD,MAAMgiE,eAG7BnlB,GACH7pC,EAAS8tD,EAAiB,uBAAwBuB,GAAuB,CAAEtrD,QAAQ,MAKzF1X,EAAE,CAAEyQ,QAAQ,EAAMiyD,MAAM,EAAMrxD,QAAS2vD,EAAezsD,MAAOysD,GAAiB,CAC5E7/C,OAAQugD,IAGV3wD,EAASuvC,EAAW8hB,KAAwB,SAAUh/D,GACpDi+D,EAAsBj+D,MAGxBpD,EAAE,CAAEM,OAAQihE,EAAQt9D,MAAM,EAAMoN,QAAS2vD,GAAiB,CAGxD,IAAO,SAAUryD,GACf,IAAIzD,EAAS9L,OAAOuP,GACpB,GAAIjL,EAAIw+D,GAAwBh3D,GAAS,OAAOg3D,GAAuBh3D,GACvE,IAAI0mB,EAAS8vC,EAAQx2D,GAGrB,OAFAg3D,GAAuBh3D,GAAU0mB,EACjCuwC,GAAuBvwC,GAAU1mB,EAC1B0mB,GAITyxC,OAAQ,SAAgBlY,GACtB,IAAKyX,GAASzX,GAAM,MAAM36C,UAAU26C,EAAM,oBAC1C,GAAIznD,EAAIy+D,GAAwBhX,GAAM,OAAOgX,GAAuBhX,IAEtEmY,UAAW,WAAchB,IAAa,GACtCiB,UAAW,WAAcjB,IAAa,KAGxCtiE,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,QAAS2vD,EAAezsD,MAAOjR,GAAe,CAG9EyX,OAAQkoD,GAGRh8D,eAAgBq5D,GAGhB18C,iBAAkBi/C,GAGlBh/D,yBAA0BD,KAG5B5D,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,QAAS2vD,GAAiB,CAG1D3+D,oBAAqBN,GAGrB6lD,sBAAuBmb,KAKzB/iE,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,OAAQtK,GAAM,WAAc0kD,EAA4BzpD,EAAE,OAAU,CACpG4lD,sBAAuB,SAA+BrlD,GACpD,OAAOkpD,EAA4BzpD,EAAE9B,EAASqC,OAM9Co/D,EAAY,CACd,IAAI6B,IAAyBxC,GAAiBj6D,GAAM,WAClD,IAAI6qB,EAAS8vC,IAEb,MAA+B,UAAxBC,EAAW,CAAC/vC,KAEe,MAA7B+vC,EAAW,CAAEhiE,EAAGiyB,KAEc,MAA9B+vC,EAAWv/D,OAAOwvB,OAGzB5xB,EAAE,CAAEM,OAAQ,OAAQ2D,MAAM,EAAMoN,OAAQmyD,IAAyB,CAE/DztD,UAAW,SAAmBxT,EAAImoD,EAAUyL,GAC1C,IAEIsN,EAFAriE,EAAO,CAACmB,GACRyJ,EAAQ,EAEZ,MAAOjM,UAAUP,OAASwM,EAAO5K,EAAKqE,KAAK1F,UAAUiM,MAErD,GADAy3D,EAAY/Y,GACP5pD,EAAS4pD,SAAoBjrD,IAAP8C,KAAoBqgE,GAASrgE,GAMxD,OALKkY,EAAQiwC,KAAWA,EAAW,SAAU/7C,EAAKrF,GAEhD,GADwB,mBAAbm6D,IAAyBn6D,EAAQm6D,EAAU/jE,KAAKiB,KAAMgO,EAAKrF,KACjEs5D,GAASt5D,GAAQ,OAAOA,IAE/BlI,EAAK,GAAKspD,EACHiX,EAAW7hE,MAAM,KAAMsB,MAO/BsgE,EAAQ1O,GAAWwO,IACtB7wD,EAA4B+wD,EAAQ1O,GAAYwO,EAAcE,EAAQ1O,GAAW0Q,SAInFnU,EAAemS,EAASH,GAExB7sD,EAAW4sD,IAAU,G,kICnTP,cAEZ,OAAO,cAAW,CAChBl+D,KAAM,KAAF,OADY,GAGhB0F,YAHgB,EAKhBvB,MAAO,CACLqa,GADK,OAEL7Y,IAAK,CACHnB,KADG,OAEHC,QAAS,QAIbqB,OAbgB,SAaV,EAbU,GAaoB,IAAzB,EAAyB,EAAzB,QAAyB,EAAzB,KAAeC,EAAU,EAAVA,SACxBvD,EAAA,YAAoB,UAAGxC,EAAH,YAAWwC,EAAA,aAAZ,IAAnB,OAEA,IAAQiJ,EAAR,EAAQA,MACR,KAAW,CAETjJ,EAAA,SACA,IAAM89C,EAAUthD,OAAA,gBAA0B,SAAAuM,GAGxC,YAAIA,EAAgB,OAAO,EAE3B,IAAMrF,EAAQuF,EALgC,GAS9C,OAAIF,EAAA,WAAJ,UACE/I,EAAA,YACA,GAGK0D,GAAP,kBAAuBA,KAGrBo6C,EAAJ,SAAoB99C,EAAA,wBAAwB89C,EAAA,KAAxB,OAQtB,OALIn8C,EAAJ,KACE3B,EAAA,SAAgBA,EAAA,UAAhB,GACAA,EAAA,YAAmB2B,EAAnB,IAGKgC,EAAEhC,EAAD,MAAR,M,gBC1CS,6BAAyB,CACtCnE,KADsC,cAEtC0F,YAFsC,EAGtCvB,MAAO,CACLqa,GADK,OAEL7Y,IAAK,CACHnB,KADG,OAEHC,QAAS,OAEX87D,MAAO,CACL/7D,KADK,QAELC,SAAS,IAGbqB,OAdsC,SAchC,EAdgC,GAcF,IAClC,EADS,EAAyB,EAAzB,QAAyB,EAAzB,KAAeC,EAAU,EAAVA,SAEhB0F,EAAR,EAAQA,MA2BR,OA1BA,IAEEjJ,EAAA,SACA89C,EAAUthD,OAAA,gBAA0B,SAAAuM,GAGlC,YAAIA,EAAgB,OAAO,EAE3B,IAAMrF,EAAQuF,EAL0B,GASxC,OAAIF,EAAA,WAAJ,UACE/I,EAAA,YACA,GAGK0D,GAAP,kBAAuBA,MAIvB/B,EAAJ,KACE3B,EAAA,SAAgBA,EAAA,UAAhB,GACAA,EAAA,YAAmB2B,EAAnB,IAGKgC,EACLhC,EADM,IAEN,OAAA+e,EAAA,MAAU1gB,EAAM,CACd4D,YADc,YAEdC,MAAO5G,MAAW,CAChB,mBAAoB0E,EAAMo8D,QADrB,OAEGjgB,GAFH,MAJX,O,qBCnDJ,IAAI1jD,EAAI,EAAQ,QACZqD,EAAO,EAAQ,QACfisD,EAA8B,EAAQ,QAEtCsU,GAAuBtU,GAA4B,SAAUz8C,GAE/DhQ,MAAMQ,KAAKwP,MAKb7S,EAAE,CAAEM,OAAQ,QAAS2D,MAAM,EAAMoN,OAAQuyD,GAAuB,CAC9DvgE,KAAMA,K,kCCXR,IAAI0D,EAAQ,EAAQ,QAEpB7H,EAAOC,QAAU,SAAUkT,EAAam3C,GACtC,IAAI1kD,EAAS,GAAGuN,GAChB,QAASvN,GAAUiC,GAAM,WAEvBjC,EAAOpF,KAAK,KAAM8pD,GAAY,WAAc,MAAM,GAAM,Q,mBCP5D,IAAIqa,EAAO/9D,KAAK+9D,KACZh+D,EAAQC,KAAKD,MAIjB3G,EAAOC,QAAU,SAAUqqD,GACzB,OAAO7uC,MAAM6uC,GAAYA,GAAY,GAAKA,EAAW,EAAI3jD,EAAQg+D,GAAMra,K,kCCLzE,IAAIxpD,EAAI,EAAQ,QACZw9C,EAAU,EAAQ,QAClBsmB,EAAgB,EAAQ,QACxB/8D,EAAQ,EAAQ,QAChByK,EAAa,EAAQ,QACrBtH,EAAqB,EAAQ,QAC7B65D,EAAiB,EAAQ,QACzBpwD,EAAW,EAAQ,QAGnBqwD,IAAgBF,GAAiB/8D,GAAM,WACzC+8D,EAAcjiE,UAAU,WAAWnC,KAAK,CAAEgG,KAAM,eAA+B,kBAqBjF,GAhBA1F,EAAE,CAAEM,OAAQ,UAAWC,OAAO,EAAM0jE,MAAM,EAAM5yD,OAAQ2yD,GAAe,CACrE,QAAW,SAAUE,GACnB,IAAIhjE,EAAIgJ,EAAmBvJ,KAAM6Q,EAAW,YACxC2yD,EAAiC,mBAAbD,EACxB,OAAOvjE,KAAK+E,KACVy+D,EAAa,SAAUzhB,GACrB,OAAOqhB,EAAe7iE,EAAGgjE,KAAax+D,MAAK,WAAc,OAAOg9C,MAC9DwhB,EACJC,EAAa,SAAUz3D,GACrB,OAAOq3D,EAAe7iE,EAAGgjE,KAAax+D,MAAK,WAAc,MAAMgH,MAC7Dw3D,OAML1mB,GAAmC,mBAAjBsmB,EAA6B,CAClD,IAAIh/D,EAAS0M,EAAW,WAAW3P,UAAU,WACzCiiE,EAAcjiE,UAAU,aAAeiD,GACzC6O,EAASmwD,EAAcjiE,UAAW,UAAWiD,EAAQ,CAAE4S,QAAQ,M,kKC/BpD,qBAAW,CACxBtU,KADwB,YAGxBmE,MAAO,CACL+qD,MAAOlzD,QAGT2O,QAAS,CACPm2C,mBADO,SACW,GAA8C,IAApBt+C,EAAoB,uDAA9C,GAChB,wBAAWA,EAAP,OAEF,eAAa,0BAFqB,MAIlC,GAEF,kBAAWA,EAAP,OAEF,eAAa,0BAFqB,MAIlC,IAEE,eAAJ,GACEA,EAAA,uCACKA,EADQ,OAAb,IAEE,6BAFW,GAGX,yBAAmB0sD,KAEZA,IACT1sD,EAAA,uCACKA,EADQ,OAAb,qBAEE,GAAS,KAIb,IAGF2yD,aA9BO,SA8BK,GAA8C,IAApB3yD,EAAoB,uDAA9C,GACV,qBAAWA,EAAP,MAIF,OAFA,eAAa,0BAFqB,MAIlC,EAEF,qBAAWA,EAAP,MAIF,OAFA,eAAa,0BAFqB,MAIlC,EAEF,GAAI,eAAJ,GACEA,EAAA,uCACKA,EADQ,OAAb,IAEE0sD,MAAO,GAAF,OAFM,GAGX,wBAAkBA,UAEf,GAAIA,EAAO,CAChB,MAAmCA,EAAA,4BAAnC,yBAAM,EAAN,KAAM,EAAN,KACA1sD,EAAA,uCACKA,EADQ,OAAb,qBAEGw+D,EAAD,UAAwB,IAE1B,IACEx+D,EAAA,MAAW,SAAX,OAGJ,c,kCCtEN,IAAItC,EAAc,EAAQ,QACtBmN,EAAS,EAAQ,QACjBqD,EAAW,EAAQ,QACnBH,EAAW,EAAQ,QACnBjQ,EAAM,EAAQ,QACd2M,EAAU,EAAQ,QAClBm/C,EAAoB,EAAQ,QAC5B/rD,EAAc,EAAQ,QACtBsD,EAAQ,EAAQ,QAChBgU,EAAS,EAAQ,QACjB1Y,EAAsB,EAAQ,QAA8CL,EAC5E6B,EAA2B,EAAQ,QAAmD7B,EACtFiF,EAAiB,EAAQ,QAAuCjF,EAChEovC,EAAO,EAAQ,QAA4BA,KAE3CizB,EAAS,SACTC,EAAe7zD,EAAO4zD,GACtBE,EAAkBD,EAAaziE,UAG/B2iE,EAAiBn0D,EAAQ0K,EAAOwpD,KAAqBF,EAIrD3pD,EAAW,SAAU8uC,GACvB,IACIyD,EAAOwX,EAAOC,EAAOC,EAASC,EAAQplE,EAAQwM,EAAOuzC,EADrDh9C,EAAKkB,EAAY+lD,GAAU,GAE/B,GAAiB,iBAANjnD,GAAkBA,EAAG/C,OAAS,EAGvC,GAFA+C,EAAK6uC,EAAK7uC,GACV0qD,EAAQ1qD,EAAG0c,WAAW,GACR,KAAVguC,GAA0B,KAAVA,GAElB,GADAwX,EAAQliE,EAAG0c,WAAW,GACR,KAAVwlD,GAA0B,MAAVA,EAAe,OAAOI,SACrC,GAAc,KAAV5X,EAAc,CACvB,OAAQ1qD,EAAG0c,WAAW,IACpB,KAAK,GAAI,KAAK,GAAIylD,EAAQ,EAAGC,EAAU,GAAI,MAC3C,KAAK,GAAI,KAAK,IAAKD,EAAQ,EAAGC,EAAU,GAAI,MAC5C,QAAS,OAAQpiE,EAInB,IAFAqiE,EAASriE,EAAGxB,MAAM,GAClBvB,EAASolE,EAAOplE,OACXwM,EAAQ,EAAGA,EAAQxM,EAAQwM,IAI9B,GAHAuzC,EAAOqlB,EAAO3lD,WAAWjT,GAGrBuzC,EAAO,IAAMA,EAAOolB,EAAS,OAAOE,IACxC,OAAO1gC,SAASygC,EAAQF,GAE5B,OAAQniE,GAKZ,GAAIuR,EAASuwD,GAASC,EAAa,UAAYA,EAAa,QAAUA,EAAa,SAAU,CAS3F,IARA,IAgBqB31D,EAhBjBm2D,EAAgB,SAAgBx7D,GAClC,IAAI/G,EAAKxC,UAAUP,OAAS,EAAI,EAAI8J,EAChCinD,EAAQ5vD,KACZ,OAAO4vD,aAAiBuU,IAElBN,EAAiBz9D,GAAM,WAAcw9D,EAAgBb,QAAQhkE,KAAK6wD,MAAalgD,EAAQkgD,IAAU8T,GACjG7U,EAAkB,IAAI8U,EAAa5pD,EAASnY,IAAMguD,EAAOuU,GAAiBpqD,EAASnY,IAElFgb,EAAOja,EAAcjB,EAAoBiiE,GAAgB,8LAQhEv5D,MAAM,KAAM0xB,EAAI,EAAQlf,EAAK/d,OAASi9B,EAAGA,IACrC/4B,EAAI4gE,EAAc31D,EAAM4O,EAAKkf,MAAQ/4B,EAAIohE,EAAen2D,IAC1D1H,EAAe69D,EAAen2D,EAAK9K,EAAyBygE,EAAc31D,IAG9Em2D,EAAcjjE,UAAY0iE,EAC1BA,EAAgBphE,YAAc2hE,EAC9BnxD,EAASlD,EAAQ4zD,EAAQS,K,qBC9E3B,IAAI/lE,EAAkB,EAAQ,QAE1BqoD,EAAQroD,EAAgB,SAE5BG,EAAOC,QAAU,SAAUkT,GACzB,IAAInG,EAAS,IACb,IACE,MAAMmG,GAAanG,GACnB,MAAO64D,GACP,IAEE,OADA74D,EAAOk7C,IAAS,EACT,MAAM/0C,GAAanG,GAC1B,MAAO84D,KACT,OAAO,I,kCCZX,IAAIhlE,EAAI,EAAQ,QACZuQ,EAAO,EAAQ,QAInBvQ,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,OAAQ,IAAId,OAASA,GAAQ,CAC9DA,KAAMA,K,kCCNR,IAAItG,EAAW,EAAQ,QAIvB/K,EAAOC,QAAU,WACf,IAAII,EAAO0K,EAAStJ,MAChBiJ,EAAS,GAOb,OANIrK,EAAKkR,SAAQ7G,GAAU,KACvBrK,EAAKiM,aAAY5B,GAAU,KAC3BrK,EAAKkM,YAAW7B,GAAU,KAC1BrK,EAAK0lE,SAAQr7D,GAAU,KACvBrK,EAAKmM,UAAS9B,GAAU,KACxBrK,EAAKoM,SAAQ/B,GAAU,KACpBA,I,sJCFM,SAAAqe,EAAA,qBAA0B,CACvC7kB,KADuC,eAGvCmE,MAAO,CACL29D,YAAa,CAAC9lE,OADT,QAEL+lE,aAAc/lE,QAGhBqO,SAAU,CACR23D,oBADQ,WAEN,OAAO73D,OAAO5M,KAAd,cAEF0kE,YAJQ,WAKN,OAAO1kE,KAAKykE,oBACR,CAAEE,cAAgB,EAAI3kE,KAAL,wBAAuC,UAD5D,GAIF4kE,cATQ,WAUN,OAAK5kE,KAAL,YAEOA,KAAK8uB,eAAe,MAAO,CAChCtgB,MAAOxO,KADyB,YAEhC6I,YAAa,wBAJe,KASlCuE,QAAS,CACPi2C,WADO,WAEL,OAAOrjD,KAAK8uB,eAAe,MAAO,CAChCjmB,YADgC,wBAEhCC,MAAO9I,KAAKwkE,cACXxkE,KAAKuN,OAHR,WAOJhF,OApCuC,SAoCjC,GACJ,OAAOK,EAAE,MAAO,CACdC,YADc,eAEd2F,MAAOxO,KAFO,iBAGdoO,GAAIpO,KAAKw7B,YACR,CACDx7B,KADC,cAEDA,KANF,kBC9CJ,I,oCC0BM6kE,EAAiC,qBAAXrjE,QAA0B,yBAAtD,OAGe,cAAA8lB,EAAA,MAAO,EAAP,eAGN,CACP7kB,KADO,QAGPwkB,WAAY,CAAEqvC,YAAA,MAEd1vD,MAAO,CACLk+D,IADK,OAELC,QAFK,QAGLC,MAHK,QAILC,SAJK,OAKLC,QALK,OAML9yD,QAAS,CACPnL,KADO,OAIPC,QAAS,iBAAO,CACdi+D,UADc,EAEdC,gBAFc,EAGd1f,eAAW5mD,KAGf2G,SAAU,CACRwB,KADQ,OAERC,QAAS,iBAEXwG,MApBK,OAqBL+W,IAAK,CACHxd,KAAM,CAACxI,OADJ,QAEHyI,QAAS,IAEXm+D,OAzBK,OA0BLj8B,WAAY,CACVniC,KAAM,CAACgG,QADG,QAEV/F,QAAS,oBAIbjC,KArCO,WAsCL,MAAO,CACLqgE,WADK,GAELpiB,MAFK,KAGLqiB,WAHK,EAILC,2BAJK,EAKLC,kBALK,EAMLC,UAAU,IAId54D,SAAU,CACR23D,oBADQ,WAEN,OAAO73D,OAAO5M,KAAK2lE,cAAcC,QAAU5lE,KAA3C,wBAEF2lE,cAJQ,WAKN,OAAO3lE,KAAKykB,KAAL,WAAY,eAAOzkB,KAAP,KACf,CACAykB,IAAKzkB,KAAKykB,IADV,IAEA4gD,OAAQrlE,KAAKqlE,QAAUrlE,KAAKykB,IAF5B,OAGAygD,QAASllE,KAAKklE,SAAWllE,KAAKykB,IAH9B,QAIAmhD,OAAQh5D,OAAO5M,KAAKukE,aAAevkE,KAAKykB,IAA1B,SACZ,CACFA,IAAKzkB,KADH,IAEFqlE,OAAQrlE,KAFN,OAGFklE,QAASllE,KAHP,QAIF4lE,OAAQh5D,OAAO5M,KAAKukE,aAAN,KAGpBsB,cAlBQ,WAmBN,KAAM7lE,KAAK2lE,cAAclhD,KAAOzkB,KAAK2lE,cAA/B,SAAwD3lE,KAA9D,UAA8E,MAAO,GAErF,IAAM8lE,EAAN,GACMrhD,EAAMzkB,KAAKulE,UAAYvlE,KAAK2lE,cAAtB,QAA8C3lE,KAA1D,WAEIA,KAAJ,UAAmB8lE,EAAA,+BAAwC9lE,KAAxC,eACnB,GAAS8lE,EAAA,6BAET,IAAM5iB,EAAQljD,KAAK8uB,eAAe,MAAO,CACvCjmB,YADuC,iBAEvCC,MAAO,CACL,0BAA2B9I,KADtB,UAEL,0BAA2BA,KAFtB,QAGL,yBAA0BA,KAAK+kE,SAEjCv2D,MAAO,CACLs3D,gBAAiBA,EAAA,KADZ,MAELC,mBAAoB/lE,KAAKyF,UAE3BuI,KAAMhO,KAAKulE,YAIb,OAAKvlE,KAAL,WAEOA,KAAK8uB,eAAe,aAAc,CACvC5gB,MAAO,CACLzL,KAAMzC,KADD,WAEL65C,KAAM,WAEP,CALH,IAF6BqJ,IAWjCtjC,MAAO,CACL6E,IADK,WAGEzkB,KAAL,UACKA,KAAKgmE,YADWhmE,KAAKqzB,UAAKv0B,OAAWA,GAA1C,IAGF,4BAA6B,UAG/BwkC,QA9GO,WA+GLtjC,KAAA,QAGFoN,QAAS,CACPimB,KADO,SACH,OAQF,IACEwxC,GAAA,GAEC7kE,KAHH,OAMA,GAAIA,KAAK2lE,cAAT,QAAgC,CAC9B,IAAMM,EAAU,IAAhB,MACAA,EAAA,IAAcjmE,KAAK2lE,cAAnB,QACA3lE,KAAA,oBAGEA,KAAK2lE,cAAT,KAA4B3lE,KAAKgmE,cAEnCE,OAvBO,WAwBLlmE,KAAA,SACAA,KAAA,aACAA,KAAA,aAAmBA,KAAnB,KAGEA,KAAKkjD,QACJljD,KAAK2lE,cAAclhD,IAAIi4C,SAAS,SAAW18D,KAAK2lE,cAAclhD,IAAIs4B,WAFrE,yBAIM/8C,KAAKkjD,MAAMijB,eAAiBnmE,KAAKkjD,MAArC,cACEljD,KAAA,aAAoBA,KAAKkjD,MAAzB,aACAljD,KAAA,sBAA6BA,KAAKkjD,MAAMuiB,aAAezlE,KAAKkjD,MAA5D,eAEAljD,KAAA,0BAINomE,QAxCO,WAyCLpmE,KAAA,YACAA,KAAA,cAAoBA,KAApB,MAEFqmE,OA5CO,WA8CDrmE,KAAJ,QAAgBA,KAAKslE,WAAatlE,KAAKkjD,MAAMoiB,YAActlE,KAAKkjD,MAAhD,MAElB8iB,UAhDO,WAgDE,WACD9iB,EAAQ,IAAd,MACAljD,KAAA,QAEAkjD,EAAA,OAAe,WAETA,EAAJ,OACEA,EAAA,gBAAsB,SAAAt6B,GACpB,OAAAU,EAAA,MACE,qEACQ,gBADR,MAECV,EAAA,oCAAmCA,EAAnC,SAHQ,IAAX,MADF,KAOQ,EAPR,QASA,YAGJs6B,EAAA,QAAgBljD,KAAhB,QAEAA,KAAA,YACAA,KAAA,QAAekjD,EAAA,MAAcljD,KAA7B,OACAA,KAAA,uBAA8BkjD,EAAA,OAAeljD,KAAK2lE,cAAlD,QACAziB,EAAA,IAAYljD,KAAK2lE,cAAjB,IACA3lE,KAAA,kBAAwBA,KAAK2lE,cAA7B,KAEA3lE,KAAA,aAAoBA,KAAKsmE,YAAzB,GACAtmE,KAAA,UAEFsmE,YA9EO,SA8EI,GAAqD,WAA5B/wD,EAA4B,uDAArD,IACHgxD,EAAO,SAAPA,IACJ,IAAM,EAAN,EAAM,cAAiBd,EAAvB,EAAuBA,aAEnBU,GAAJ,GACE,iBACA,wBAA6BV,EAA7B,GACUtiB,EAAD,WAAiB,EAAjB,WAAoC,EAApC,UAAJ,MAAyD5tC,GAC9DsU,WAAW08C,EAAX,IAIJA,KAEFljB,WA5FO,WA6FL,IAAMqP,EAAiB,kCAAvB,MAOA,OANI1yD,KAAJ,cACEA,KAAA,GAAQ0yD,EAAR,WAA8B,CAC5BlkD,MAAO,CAAEE,MAAO,GAAF,OAAK1O,KAAKylE,aAAV,SAIlB,GAEFe,iBAtGO,WAuGL,GAAIxmE,KAAKuN,OAAT,YAA6B,CAC3B,IAAM0sC,EAAcj6C,KAAKulE,UACrB,CAACvlE,KAAK8uB,eAAe,MAAO,CAC5BjmB,YAAa,wBACZ7I,KAAKuN,OAHU,cAApB,GAMA,OAAKvN,KAAL,WAEOA,KAAK8uB,eAAe,aAAc,CACvCloB,MAAO,CACLsvC,QADK,EAELzzC,KAAMzC,KAAKopC,aAHf,GAF6B6Q,EAAP,MAY5B1xC,OA5OO,SA4OD,GACJ,IAAM4a,EAAO,2BAAb,GAEMle,EAAO,OAAA0gB,EAAA,MAAUxC,EAAD,KAAa,CACjCta,YADiC,UAEjCqF,MAAO,CACL,aAAclO,KADT,IAELqP,KAAMrP,KAAK8kE,IAAM,WAAQhmE,GAE3BgK,MAAO9I,KAN0B,aASjCinB,WAAY49C,EACR,CAAC,CACDpiE,KADC,YAED4qC,UAAW,CAAEtwB,MAAM,GACnBpU,MAAO,CACLwgB,QAASnpB,KADJ,KAELoS,QAASpS,KAAKoS,gBAGhBtT,IAUN,OAPAqkB,EAAA,SAAgB,CACdnjB,KADc,cAEdA,KAFc,cAGdA,KAHc,mBAIdA,KAJF,cAOO4I,EAAEua,EAAD,MAAiBA,EAAzB,c,kCC9SW,SAASsjD,EAAgBntD,EAAKtL,EAAKrF,GAYhD,OAXIqF,KAAOsL,EACT7X,OAAO6E,eAAegT,EAAKtL,EAAK,CAC9BrF,MAAOA,EACP4V,YAAY,EACZrH,cAAc,EACdsH,UAAU,IAGZlF,EAAItL,GAAOrF,EAGN2Q,EAZT,mC,kCCCA,IAcIw6C,EAAmB4S,EAAmCC,EAdtDvgE,EAAQ,EAAQ,QAChBq5C,EAAiB,EAAQ,QACzBzvC,EAA8B,EAAQ,QACtCjN,EAAM,EAAQ,QACd3E,EAAkB,EAAQ,QAC1By+C,EAAU,EAAQ,QAElB/rC,EAAW1S,EAAgB,YAC3B21D,GAAyB,EAEzBI,EAAa,WAAc,OAAOn0D,MAOlC,GAAG4c,OACL+pD,EAAgB,GAAG/pD,OAEb,SAAU+pD,GAEdD,EAAoCjnB,EAAeA,EAAeknB,IAC9DD,IAAsCjlE,OAAOP,YAAW4yD,EAAoB4S,IAHlD3S,GAAyB,GAO3D,IAAI6S,OAA8C9nE,GAArBg1D,GAAkC1tD,GAAM,WACnE,IAAI9H,EAAO,GAEX,OAAOw1D,EAAkBhjD,GAAU/R,KAAKT,KAAUA,KAGhDsoE,IAAwB9S,EAAoB,IAG1CjX,IAAW+pB,GAA4B7jE,EAAI+wD,EAAmBhjD,IAClEd,EAA4B8jD,EAAmBhjD,EAAUqjD,GAG3D51D,EAAOC,QAAU,CACfs1D,kBAAmBA,EACnBC,uBAAwBA,I,qBC3C1B,IAAI3tD,EAAQ,EAAQ,QAIpB7H,EAAOC,QAAU,SAAUkT,GACzB,OAAOtL,GAAM,WACX,IAAI9H,EAAO,GAAGoT,GAAa,KAC3B,OAAOpT,IAASA,EAAK8F,eAAiB9F,EAAK8L,MAAM,KAAKvL,OAAS,O,4DCLpD,qBAAW,CACxB4D,KADwB,WAGxBmE,MAAO,CACLiH,MADK,QAELD,MAFK,QAGLE,OAHK,QAILH,OAAQV,SAGVH,SAAU,CACRC,OADQ,WAEN,OAAOE,SACJjN,KAAD,SACCA,KADD,QAECA,KAFD,QAGCA,KAJH,SAOFy7D,gBATQ,WAUN,MAAO,CACL,kBAAmBz7D,KADd,OAEL,gBAAiBA,KAFZ,MAGL,kBAAmBA,KAHd,OAIL,gBAAiBA,KAJZ,MAKL,kBAAmBA,KAAK8N,a,kCC1BhC,IAAI+4D,EAAwB,EAAQ,QAChCn3D,EAAU,EAAQ,QAItBnR,EAAOC,QAAUqoE,EAAwB,GAAGvlE,SAAW,WACrD,MAAO,WAAaoO,EAAQ1P,MAAQ,M,qBCPtC,IAAI2C,EAAc,EAAQ,QACtB2D,EAAiB,EAAQ,QAAuCjF,EAEhEylE,EAAoBlmE,SAASM,UAC7B6lE,EAA4BD,EAAkBxlE,SAC9C0lE,EAAS,wBACTzW,EAAO,OAIP5tD,KAAiB4tD,KAAQuW,IAC3BxgE,EAAewgE,EAAmBvW,EAAM,CACtCr5C,cAAc,EACd3Q,IAAK,WACH,IACE,OAAOwgE,EAA0BhoE,KAAKiB,MAAMgG,MAAMghE,GAAQ,GAC1D,MAAOnlE,GACP,MAAO,Q,kCCff,IAAI2B,EAAQ,EAAQ,QAChByjE,EAAS,EAAQ,QACjBC,EAAW,EAAQ,QACnBC,EAAe,EAAQ,QACvBC,EAAkB,EAAQ,QAC1BrgB,EAAc,EAAQ,QAE1BxoD,EAAOC,QAAU,SAAoBwF,GACnC,OAAO,IAAIO,SAAQ,SAA4BC,EAAS8zB,GACtD,IAAI+uC,EAAcrjE,EAAOiB,KACrBqiE,EAAiBtjE,EAAOmQ,QAExB3Q,EAAMkR,WAAW2yD,WACZC,EAAe,gBAGxB,IAAIxjE,EAAU,IAAIyQ,eAGlB,GAAIvQ,EAAOujE,KAAM,CACf,IAAIC,EAAWxjE,EAAOujE,KAAKC,UAAY,GACnCC,EAAWzjE,EAAOujE,KAAKE,UAAY,GACvCH,EAAeI,cAAgB,SAAWC,KAAKH,EAAW,IAAMC,GA8DlE,GA3DA3jE,EAAQsvD,KAAKpvD,EAAOG,OAAO6W,cAAeksD,EAASljE,EAAOE,IAAKF,EAAO6nB,OAAQ7nB,EAAOi7C,mBAAmB,GAGxGn7C,EAAQyR,QAAUvR,EAAOuR,QAGzBzR,EAAQ8jE,mBAAqB,WAC3B,GAAK9jE,GAAkC,IAAvBA,EAAQ+jE,aAQD,IAAnB/jE,EAAQ8R,QAAkB9R,EAAQgkE,aAAwD,IAAzChkE,EAAQgkE,YAAYtxD,QAAQ,UAAjF,CAKA,IAAIuxD,EAAkB,0BAA2BjkE,EAAUqjE,EAAarjE,EAAQkkE,yBAA2B,KACvGC,EAAgBjkE,EAAOkkE,cAAwC,SAAxBlkE,EAAOkkE,aAAiDpkE,EAAQC,SAA/BD,EAAQqkE,aAChFpkE,EAAW,CACbkB,KAAMgjE,EACNryD,OAAQ9R,EAAQ8R,OAChBwyD,WAAYtkE,EAAQskE,WACpBj0D,QAAS4zD,EACT/jE,OAAQA,EACRF,QAASA,GAGXmjE,EAAOziE,EAAS8zB,EAAQv0B,GAGxBD,EAAU,OAIZA,EAAQukE,QAAU,WAGhB/vC,EAAOyuB,EAAY,gBAAiB/iD,EAAQ,KAAMF,IAGlDA,EAAU,MAIZA,EAAQwkE,UAAY,WAClBhwC,EAAOyuB,EAAY,cAAgB/iD,EAAOuR,QAAU,cAAevR,EAAQ,eACzEF,IAGFA,EAAU,MAMRN,EAAM+8C,uBAAwB,CAChC,IAAIgoB,EAAU,EAAQ,QAGlBC,GAAaxkE,EAAOykE,iBAAmBrB,EAAgBpjE,EAAOE,OAASF,EAAOwR,eAC9E+yD,EAAQ9W,KAAKztD,EAAOwR,qBACpB1W,EAEA0pE,IACFlB,EAAetjE,EAAOyR,gBAAkB+yD,GAuB5C,GAlBI,qBAAsB1kE,GACxBN,EAAMiB,QAAQ6iE,GAAgB,SAA0Bv/D,EAAKiG,GAChC,qBAAhBq5D,GAAqD,iBAAtBr5D,EAAI5J,qBAErCkjE,EAAet5D,GAGtBlK,EAAQ4kE,iBAAiB16D,EAAKjG,MAMhC/D,EAAOykE,kBACT3kE,EAAQ2kE,iBAAkB,GAIxBzkE,EAAOkkE,aACT,IACEpkE,EAAQokE,aAAelkE,EAAOkkE,aAC9B,MAAOn8D,GAGP,GAA4B,SAAxB/H,EAAOkkE,aACT,MAAMn8D,EAM6B,oBAA9B/H,EAAO2kE,oBAChB7kE,EAAQic,iBAAiB,WAAY/b,EAAO2kE,oBAIP,oBAA5B3kE,EAAO4kE,kBAAmC9kE,EAAQ+kE,QAC3D/kE,EAAQ+kE,OAAO9oD,iBAAiB,WAAY/b,EAAO4kE,kBAGjD5kE,EAAOmlD,aAETnlD,EAAOmlD,YAAY7kD,QAAQS,MAAK,SAAoB24D,GAC7C55D,IAILA,EAAQglE,QACRxwC,EAAOolC,GAEP55D,EAAU,cAIMhF,IAAhBuoE,IACFA,EAAc,MAIhBvjE,EAAQilE,KAAK1B,Q,qBC/JjB,IAeI2B,EAAOC,EAAMp8C,EAAMrL,EAAQ22C,EAAQh1C,EAAM7e,EAASS,EAflD+K,EAAS,EAAQ,QACjB5M,EAA2B,EAAQ,QAAmD7B,EACtF6nE,EAAY,EAAQ,QAAqBtoD,IACzC28B,EAAS,EAAQ,QACjB4rB,EAAkB,EAAQ,QAC1B3rB,EAAU,EAAQ,QAElB1zB,EAAmBha,EAAOga,kBAAoBha,EAAOs5D,uBACrDj/C,EAAWra,EAAOqa,SAClB3V,EAAU1E,EAAO0E,QACjBjQ,EAAUuL,EAAOvL,QAEjB8kE,EAA2BnmE,EAAyB4M,EAAQ,kBAC5Dw5D,EAAiBD,GAA4BA,EAAyB1gE,MAKrE2gE,IACHN,EAAQ,WACN,IAAI/wD,EAAQtZ,EACR6+C,IAAYvlC,EAASzD,EAAQ48C,SAASn5C,EAAOsxD,OACjD,MAAON,EAAM,CACXtqE,EAAKsqE,EAAKtqE,GACVsqE,EAAOA,EAAK/3D,KACZ,IACEvS,IACA,MAAOkD,GAGP,MAFIonE,EAAMznD,IACLqL,OAAO/tB,EACN+C,GAERgrB,OAAO/tB,EACLmZ,GAAQA,EAAOs9B,SAKhBgI,GAAWC,GAAY2rB,IAAmBr/C,IAAoBK,EAQxD5lB,GAAWA,EAAQC,SAE5BF,EAAUC,EAAQC,aAAQ1F,GAE1BwF,EAAQ9B,YAAc+B,EACtBQ,EAAOT,EAAQS,KACfyc,EAAS,WACPzc,EAAKhG,KAAKuF,EAAS0kE,KAIrBxnD,EADSg8B,EACA,WACPhpC,EAAQ8V,SAAS0+C,IASV,WAEPE,EAAUnqE,KAAK+Q,EAAQk5D,KA9BzB7Q,GAAS,EACTh1C,EAAOgH,EAASC,eAAe,IAC/B,IAAIN,EAAiBk/C,GAAOrkD,QAAQxB,EAAM,CAAEkH,eAAe,IAC3D7I,EAAS,WACP2B,EAAKle,KAAOkzD,GAAUA,KA+B5B55D,EAAOC,QAAU8qE,GAAkB,SAAU3qE,GAC3C,IAAI6qE,EAAO,CAAE7qE,GAAIA,EAAIuS,UAAMpS,GACvB+tB,IAAMA,EAAK3b,KAAOs4D,GACjBP,IACHA,EAAOO,EACPhoD,KACAqL,EAAO28C,I,qBChFX,IAAI15D,EAAS,EAAQ,QACjBi+C,EAAS,EAAQ,QACjBhrD,EAAM,EAAQ,QACdge,EAAM,EAAQ,QACds/C,EAAgB,EAAQ,QACxBC,EAAoB,EAAQ,QAE5BmB,EAAwB1T,EAAO,OAC/BvtC,EAAS1Q,EAAO0Q,OAChBipD,EAAwBnJ,EAAoB9/C,EAASA,GAAUA,EAAOkpD,eAAiB3oD,EAE3FxiB,EAAOC,QAAU,SAAUiE,GAOvB,OANGM,EAAI0+D,EAAuBh/D,KAAW49D,GAAuD,iBAA/BoB,EAAsBh/D,MACnF49D,GAAiBt9D,EAAIyd,EAAQ/d,GAC/Bg/D,EAAsBh/D,GAAQ+d,EAAO/d,GAErCg/D,EAAsBh/D,GAAQgnE,EAAsB,UAAYhnE,IAE3Dg/D,EAAsBh/D,K,qBClBjC,IAAIpD,EAAI,EAAQ,QACZE,EAAW,EAAQ,QACnBoqE,EAAa,EAAQ,QACrBvjE,EAAQ,EAAQ,QAEhBo5C,EAAsBp5C,GAAM,WAAcujE,EAAW,MAIzDtqE,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,OAAQ8uC,GAAuB,CAC/D5iC,KAAM,SAAchb,GAClB,OAAO+nE,EAAWpqE,EAASqC,Q,kCCV/B,IAAIvC,EAAI,EAAQ,QACZI,EAAY,EAAQ,QACpBmqE,EAAkB,EAAQ,QAC1BtpB,EAAS,EAAQ,QACjBl6C,EAAQ,EAAQ,QAEhByjE,EAAgB,GAAIC,QACpB5kE,EAAQC,KAAKD,MAEb28C,EAAM,SAAUE,EAAGx/C,EAAGwnE,GACxB,OAAa,IAANxnE,EAAUwnE,EAAMxnE,EAAI,IAAM,EAAIs/C,EAAIE,EAAGx/C,EAAI,EAAGwnE,EAAMhoB,GAAKF,EAAIE,EAAIA,EAAGx/C,EAAI,EAAGwnE,IAG9EC,EAAM,SAAUjoB,GAClB,IAAIx/C,EAAI,EACJ0nE,EAAKloB,EACT,MAAOkoB,GAAM,KACX1nE,GAAK,GACL0nE,GAAM,KAER,MAAOA,GAAM,EACX1nE,GAAK,EACL0nE,GAAM,EACN,OAAO1nE,GAGP2nE,EAAW,SAAUjlE,EAAM1C,EAAGrD,GAChC,IAAImM,GAAS,EACT8+D,EAAKjrE,EACT,QAASmM,EAAQ,EACf8+D,GAAM5nE,EAAI0C,EAAKoG,GACfpG,EAAKoG,GAAS8+D,EAAK,IACnBA,EAAKjlE,EAAMilE,EAAK,MAIhBC,EAAS,SAAUnlE,EAAM1C,GAC3B,IAAI8I,EAAQ,EACRnM,EAAI,EACR,QAASmM,GAAS,EAChBnM,GAAK+F,EAAKoG,GACVpG,EAAKoG,GAASnG,EAAMhG,EAAIqD,GACxBrD,EAAKA,EAAIqD,EAAK,KAId8nE,EAAe,SAAUplE,GAC3B,IAAIoG,EAAQ,EACRiqC,EAAI,GACR,QAASjqC,GAAS,EAChB,GAAU,KAANiqC,GAAsB,IAAVjqC,GAA+B,IAAhBpG,EAAKoG,GAAc,CAChD,IAAIi/D,EAAI7rE,OAAOwG,EAAKoG,IACpBiqC,EAAU,KAANA,EAAWg1B,EAAIh1B,EAAIgL,EAAOvhD,KAAK,IAAK,EAAIurE,EAAEzrE,QAAUyrE,EAE1D,OAAOh1B,GAGPliC,EAASy2D,IACY,UAAvB,KAAQC,QAAQ,IACG,MAAnB,GAAIA,QAAQ,IACS,SAArB,MAAMA,QAAQ,IACuB,yBAArC,mBAAsBA,QAAQ,MAC1B1jE,GAAM,WAEVyjE,EAAc9qE,KAAK,OAKrBM,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,OAAQ0C,GAAU,CACnD02D,QAAS,SAAiBS,GACxB,IAKIx+D,EAAGC,EAAG8vB,EAAG2jC,EALTjvB,EAASo5B,EAAgB5pE,MACzBwqE,EAAc/qE,EAAU8qE,GACxBtlE,EAAO,CAAC,EAAG,EAAG,EAAG,EAAG,EAAG,GACvB08C,EAAO,GACP14C,EAAS,IAGb,GAAIuhE,EAAc,GAAKA,EAAc,GAAI,MAAMrhE,WAAW,6BAE1D,GAAIqnC,GAAUA,EAAQ,MAAO,MAC7B,GAAIA,IAAW,MAAQA,GAAU,KAAM,OAAO/xC,OAAO+xC,GAKrD,GAJIA,EAAS,IACXmR,EAAO,IACPnR,GAAUA,GAERA,EAAS,MAKX,GAJAzkC,EAAIi+D,EAAIx5B,EAASqR,EAAI,EAAG,GAAI,IAAM,GAClC71C,EAAID,EAAI,EAAIykC,EAASqR,EAAI,GAAI91C,EAAG,GAAKykC,EAASqR,EAAI,EAAG91C,EAAG,GACxDC,GAAK,iBACLD,EAAI,GAAKA,EACLA,EAAI,EAAG,CACTm+D,EAASjlE,EAAM,EAAG+G,GAClB8vB,EAAI0uC,EACJ,MAAO1uC,GAAK,EACVouC,EAASjlE,EAAM,IAAK,GACpB62B,GAAK,EAEPouC,EAASjlE,EAAM48C,EAAI,GAAI/lB,EAAG,GAAI,GAC9BA,EAAI/vB,EAAI,EACR,MAAO+vB,GAAK,GACVsuC,EAAOnlE,EAAM,GAAK,IAClB62B,GAAK,GAEPsuC,EAAOnlE,EAAM,GAAK62B,GAClBouC,EAASjlE,EAAM,EAAG,GAClBmlE,EAAOnlE,EAAM,GACbgE,EAASohE,EAAaplE,QAEtBilE,EAASjlE,EAAM,EAAG+G,GAClBk+D,EAASjlE,EAAM,IAAM8G,EAAG,GACxB9C,EAASohE,EAAaplE,GAAQq7C,EAAOvhD,KAAK,IAAKyrE,GAUjD,OAPEA,EAAc,GAChB/K,EAAIx2D,EAAOpK,OACXoK,EAAS04C,GAAQ8d,GAAK+K,EAClB,KAAOlqB,EAAOvhD,KAAK,IAAKyrE,EAAc/K,GAAKx2D,EAC3CA,EAAO7I,MAAM,EAAGq/D,EAAI+K,GAAe,IAAMvhE,EAAO7I,MAAMq/D,EAAI+K,KAE9DvhE,EAAS04C,EAAO14C,EACTA,M,qBC1Hb,IAAInI,EAAO,EAAQ,QACfuqD,EAAgB,EAAQ,QACxB9rD,EAAW,EAAQ,QACnBC,EAAW,EAAQ,QACnBE,EAAqB,EAAQ,QAE7BoF,EAAO,GAAGA,KAGV+iD,EAAe,SAAUsD,GAC3B,IAAI8B,EAAiB,GAAR9B,EACTsf,EAAoB,GAARtf,EACZuf,EAAkB,GAARvf,EACVwf,EAAmB,GAARxf,EACXyf,EAAwB,GAARzf,EAChB0f,EAAwB,GAAR1f,EAChB2f,EAAmB,GAAR3f,GAAayf,EAC5B,OAAO,SAAU7iB,EAAOx3C,EAAY3R,EAAMmsE,GASxC,IARA,IAOIpiE,EAAOM,EAPPlJ,EAAIR,EAASwoD,GACbvE,EAAO6H,EAActrD,GACrBiB,EAAgBF,EAAKyP,EAAY3R,EAAM,GACvCC,EAASW,EAASgkD,EAAK3kD,QACvBwM,EAAQ,EACR+O,EAAS2wD,GAAkBrrE,EAC3BC,EAASstD,EAAS7yC,EAAO2tC,EAAOlpD,GAAU4rE,GAAaI,EAAgBzwD,EAAO2tC,EAAO,QAAKjpD,EAExFD,EAASwM,EAAOA,IAAS,IAAIy/D,GAAYz/D,KAASm4C,KACtD76C,EAAQ66C,EAAKn4C,GACbpC,EAASjI,EAAc2H,EAAO0C,EAAOtL,GACjCorD,GACF,GAAI8B,EAAQttD,EAAO0L,GAASpC,OACvB,GAAIA,EAAQ,OAAQkiD,GACvB,KAAK,EAAG,OAAO,EACf,KAAK,EAAG,OAAOxiD,EACf,KAAK,EAAG,OAAO0C,EACf,KAAK,EAAGvG,EAAK/F,KAAKY,EAAQgJ,QACrB,OAAQwiD,GACb,KAAK,EAAG,OAAO,EACf,KAAK,EAAGrmD,EAAK/F,KAAKY,EAAQgJ,GAIhC,OAAOiiE,GAAiB,EAAIF,GAAWC,EAAWA,EAAWhrE,IAIjEpB,EAAOC,QAAU,CAGfiG,QAASojD,EAAa,GAGtB1tC,IAAK0tC,EAAa,GAGlBllB,OAAQklB,EAAa,GAGrB37C,KAAM27C,EAAa,GAGnBrrC,MAAOqrC,EAAa,GAGpB2L,KAAM3L,EAAa,GAGnBmjB,UAAWnjB,EAAa,GAGxBojB,UAAWpjB,EAAa,K,gJCrEX,SAASqjB,EAA2B9oE,EAAG+oE,GACpD,IAAIvpE,EAAuB,qBAAX4e,QAA0Bpe,EAAEoe,OAAOnO,WAAajQ,EAAE,cAElE,IAAKR,EAAI,CACP,GAAIM,MAAM4X,QAAQ1X,KAAOR,EAAKw+C,eAA2Bh+C,KAAO+oE,GAAkB/oE,GAAyB,kBAAbA,EAAEvD,OAAqB,CAC/G+C,IAAIQ,EAAIR,GACZ,IAAIjB,EAAI,EAEJ2mD,EAAI,aAER,MAAO,CACLhS,EAAGgS,EACH/kD,EAAG,WACD,OAAI5B,GAAKyB,EAAEvD,OAAe,CACxB4M,MAAM,GAED,CACLA,MAAM,EACN9C,MAAOvG,EAAEzB,OAGboL,EAAG,SAAWgmB,GACZ,MAAMA,GAER1wB,EAAGimD,GAIP,MAAM,IAAIz3C,UAAU,yIAGtB,IAEI+Y,EAFAwiD,GAAmB,EACnBC,GAAS,EAEb,MAAO,CACL/1B,EAAG,WACD1zC,EAAKA,EAAG7C,KAAKqD,IAEfG,EAAG,WACD,IAAIgQ,EAAO3Q,EAAGsP,OAEd,OADAk6D,EAAmB74D,EAAK9G,KACjB8G,GAETxG,EAAG,SAAWu/D,GACZD,GAAS,EACTziD,EAAM0iD,GAERjqE,EAAG,WACD,IACO+pE,GAAoC,MAAhBxpE,EAAG,WAAmBA,EAAG,YADpD,QAGE,GAAIypE,EAAQ,MAAMziD,O,qBCpD1B,IAAIxiB,EAAQ,EAAQ,QAEpB7H,EAAOC,SAAW4H,GAAM,WAEtB,OAAO3E,OAAOojB,aAAapjB,OAAO8pE,kBAAkB,S,qBCJtDhtE,EAAOC,QAAU,EAAQ,S,4CCAzB,IAAI2B,EAAW,EAAQ,QAMvB5B,EAAOC,QAAU,SAAUqgE,EAAO2M,GAChC,IAAKrrE,EAAS0+D,GAAQ,OAAOA,EAC7B,IAAIlgE,EAAIoJ,EACR,GAAIyjE,GAAoD,mBAAxB7sE,EAAKkgE,EAAMv9D,YAA4BnB,EAAS4H,EAAMpJ,EAAGI,KAAK8/D,IAAS,OAAO92D,EAC9G,GAAmC,mBAAvBpJ,EAAKkgE,EAAMkE,WAA2B5iE,EAAS4H,EAAMpJ,EAAGI,KAAK8/D,IAAS,OAAO92D,EACzF,IAAKyjE,GAAoD,mBAAxB7sE,EAAKkgE,EAAMv9D,YAA4BnB,EAAS4H,EAAMpJ,EAAGI,KAAK8/D,IAAS,OAAO92D,EAC/G,MAAM8H,UAAU,6C,kCCVlB,IAAIrM,EAAQ,EAAQ,QAIhBioE,EAAoB,CACtB,MAAO,gBAAiB,iBAAkB,eAAgB,OAC1D,UAAW,OAAQ,OAAQ,oBAAqB,sBAChD,gBAAiB,WAAY,eAAgB,sBAC7C,UAAW,cAAe,cAgB5BltE,EAAOC,QAAU,SAAsB2V,GACrC,IACInG,EACAjG,EACApH,EAHAqgD,EAAS,GAKb,OAAK7sC,GAEL3Q,EAAMiB,QAAQ0P,EAAQ/J,MAAM,OAAO,SAAgBshE,GAKjD,GAJA/qE,EAAI+qE,EAAKl1D,QAAQ,KACjBxI,EAAMxK,EAAMitC,KAAKi7B,EAAKC,OAAO,EAAGhrE,IAAIyD,cACpC2D,EAAMvE,EAAMitC,KAAKi7B,EAAKC,OAAOhrE,EAAI,IAE7BqN,EAAK,CACP,GAAIgzC,EAAOhzC,IAAQy9D,EAAkBj1D,QAAQxI,IAAQ,EACnD,OAGAgzC,EAAOhzC,GADG,eAARA,GACagzC,EAAOhzC,GAAOgzC,EAAOhzC,GAAO,IAAI/M,OAAO,CAAC8G,IAEzCi5C,EAAOhzC,GAAOgzC,EAAOhzC,GAAO,KAAOjG,EAAMA,MAKtDi5C,GAnBgBA,I,kCC9BzB,IAAIx9C,EAAQ,EAAQ,QAUpBjF,EAAOC,QAAU,SAAuByG,EAAMkP,EAASiX,GAMrD,OAJA5nB,EAAMiB,QAAQ2mB,GAAK,SAAmBzsB,GACpCsG,EAAOtG,EAAGsG,EAAMkP,MAGXlP,I,mBClBT1G,EAAOC,SAAU,G,kCCEjB,IAAIsC,EAAO,EAAQ,QACf8T,EAAW,EAAQ,QAMnBtT,EAAWG,OAAOP,UAAUI,SAQhC,SAASwY,EAAQ/R,GACf,MAA8B,mBAAvBzG,EAASvC,KAAKgJ,GASvB,SAAS4M,EAAc5M,GACrB,MAA8B,yBAAvBzG,EAASvC,KAAKgJ,GASvB,SAAS2M,EAAW3M,GAClB,MAA4B,qBAAb6jE,UAA8B7jE,aAAe6jE,SAS9D,SAAS52D,EAAkBjN,GACzB,IAAIkB,EAMJ,OAJEA,EAD0B,qBAAhB4iE,aAAiCA,YAAkB,OACpDA,YAAYC,OAAO/jE,GAEnB,GAAUA,EAAU,QAAMA,EAAIkN,kBAAkB42D,YAEpD5iE,EAST,SAASg4C,EAASl5C,GAChB,MAAsB,kBAARA,EAShB,SAASwpD,EAASxpD,GAChB,MAAsB,kBAARA,EAShB,SAASqM,EAAYrM,GACnB,MAAsB,qBAARA,EAShB,SAAS5H,EAAS4H,GAChB,OAAe,OAARA,GAA+B,kBAARA,EAShC,SAASq3C,EAAOr3C,GACd,MAA8B,kBAAvBzG,EAASvC,KAAKgJ,GASvB,SAAS+M,EAAO/M,GACd,MAA8B,kBAAvBzG,EAASvC,KAAKgJ,GASvB,SAASgN,EAAOhN,GACd,MAA8B,kBAAvBzG,EAASvC,KAAKgJ,GASvB,SAASy7D,EAAWz7D,GAClB,MAA8B,sBAAvBzG,EAASvC,KAAKgJ,GASvB,SAAS8M,EAAS9M,GAChB,OAAO5H,EAAS4H,IAAQy7D,EAAWz7D,EAAIgkE,MASzC,SAAS72D,EAAkBnN,GACzB,MAAkC,qBAApBikE,iBAAmCjkE,aAAeikE,gBASlE,SAASv7B,EAAKjrC,GACZ,OAAOA,EAAIJ,QAAQ,OAAQ,IAAIA,QAAQ,OAAQ,IAgBjD,SAASm7C,IACP,OAAyB,qBAAdlhC,WAAmD,gBAAtBA,UAAU4sD,WAI9B,qBAAXzqE,QACa,qBAAb2oB,UAgBX,SAAS1lB,EAAQ6U,EAAK3a,GAEpB,GAAY,OAAR2a,GAA+B,qBAARA,EAU3B,GALmB,kBAARA,IAETA,EAAM,CAACA,IAGLQ,EAAQR,GAEV,IAAK,IAAI3Y,EAAI,EAAG4a,EAAIjC,EAAIza,OAAQ8B,EAAI4a,EAAG5a,IACrChC,EAAGI,KAAK,KAAMua,EAAI3Y,GAAIA,EAAG2Y,QAI3B,IAAK,IAAItL,KAAOsL,EACV7X,OAAOP,UAAUuZ,eAAe1b,KAAKua,EAAKtL,IAC5CrP,EAAGI,KAAK,KAAMua,EAAItL,GAAMA,EAAKsL,GAuBrC,SAASrV,IACP,IAAIgF,EAAS,GACb,SAASijE,EAAYnkE,EAAKiG,GACG,kBAAhB/E,EAAO+E,IAAoC,kBAARjG,EAC5CkB,EAAO+E,GAAO/J,EAAMgF,EAAO+E,GAAMjG,GAEjCkB,EAAO+E,GAAOjG,EAIlB,IAAK,IAAIpH,EAAI,EAAG4a,EAAInc,UAAUP,OAAQ8B,EAAI4a,EAAG5a,IAC3C8D,EAAQrF,UAAUuB,GAAIurE,GAExB,OAAOjjE,EAWT,SAAS4S,EAAO7c,EAAGC,EAAGsS,GAQpB,OAPA9M,EAAQxF,GAAG,SAAqB8I,EAAKiG,GAEjChP,EAAEgP,GADAuD,GAA0B,oBAARxJ,EACXjH,EAAKiH,EAAKwJ,GAEVxJ,KAGN/I,EAGTT,EAAOC,QAAU,CACfsb,QAASA,EACTnF,cAAeA,EACfC,SAAUA,EACVF,WAAYA,EACZM,kBAAmBA,EACnBisC,SAAUA,EACVsQ,SAAUA,EACVpxD,SAAUA,EACViU,YAAaA,EACbgrC,OAAQA,EACRtqC,OAAQA,EACRC,OAAQA,EACRyuD,WAAYA,EACZ3uD,SAAUA,EACVK,kBAAmBA,EACnBqrC,qBAAsBA,EACtB97C,QAASA,EACTR,MAAOA,EACP4X,OAAQA,EACR40B,KAAMA,I,mBC7SR,IAAInvC,EAAW,GAAGA,SAElB/C,EAAOC,QAAU,SAAUoD,GACzB,OAAON,EAASvC,KAAK6C,GAAIxB,MAAM,GAAI,K,qBCHrC,IAAI0P,EAAS,EAAQ,QACjBmD,EAAY,EAAQ,QAEpBk5D,EAAS,qBACTxhB,EAAQ76C,EAAOq8D,IAAWl5D,EAAUk5D,EAAQ,IAEhD5tE,EAAOC,QAAUmsD,G,kCCLjB,IAAItrD,EAAI,EAAQ,QACZmR,EAAa,EAAQ,QACrBC,EAAyB,EAAQ,QAIrCpR,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,OAAQD,EAAuB,UAAY,CAC5E27D,MAAO,WACL,OAAO57D,EAAWxQ,KAAM,KAAM,GAAI,Q;;;;;;;ACFtCzB,EAAOC,QAAU,SAAmB8a,GAClC,OAAc,MAAPA,GAAkC,MAAnBA,EAAI9W,aACY,oBAA7B8W,EAAI9W,YAAYoS,UAA2B0E,EAAI9W,YAAYoS,SAAS0E,K,kCCP/E,IAAI9V,EAAQ,EAAQ,QAEpBjF,EAAOC,QAAU,SAA6B2V,EAASu9B,GACrDluC,EAAMiB,QAAQ0P,GAAS,SAAuBxL,EAAOlG,GAC/CA,IAASivC,GAAkBjvC,EAAKuY,gBAAkB02B,EAAe12B,gBACnE7G,EAAQu9B,GAAkB/oC,SACnBwL,EAAQ1R,S,mBCRrB,IAAIy6D,EAGJA,EAAI,WACH,OAAOl9D,KADJ,GAIJ,IAECk9D,EAAIA,GAAK,IAAIt8D,SAAS,cAAb,GACR,MAAOmL,GAEc,kBAAXvK,SAAqB07D,EAAI17D,QAOrCjD,EAAOC,QAAU0+D,G,qBCnBjB,IAAI92D,EAAQ,EAAQ,QAChB2kD,EAAc,EAAQ,QAEtBshB,EAAM,MAIV9tE,EAAOC,QAAU,SAAUkT,GACzB,OAAOtL,GAAM,WACX,QAAS2kD,EAAYr5C,MAAkB26D,EAAI36D,MAAkB26D,GAAOthB,EAAYr5C,GAAajP,OAASiP,O,kCCR1G,IAAIrS,EAAI,EAAQ,QACZmR,EAAa,EAAQ,QACrBC,EAAyB,EAAQ,QAIrCpR,EAAE,CAAEM,OAAQ,SAAUC,OAAO,EAAM8Q,OAAQD,EAAuB,UAAY,CAC5E7C,MAAO,WACL,OAAO4C,EAAWxQ,KAAM,QAAS,GAAI,Q,0ECP1B,qBAAW,CACxByC,KADwB,aAGxBmE,MAAO,CACLm1D,UAAW,CAACnvD,OAAQnO,SAGtBqO,SAAU,CACR4uD,kBADQ,WAEN,OAAO17D,KAAP,WAEFssE,iBAJQ,WAKN,IAAMvQ,EAAY/7D,KAAlB,kBAEA,aAAI+7D,GACA/hD,MAAMwpB,SAAV,IAD8B,GAE9B,sCAAuBxjC,KAAd,YAAiC,Q,qBClBhD,IAAI+C,EAAM,EAAQ,QACd5B,EAAkB,EAAQ,QAC1BqV,EAAU,EAAQ,QAA+BA,QACjDzC,EAAa,EAAQ,QAEzBxV,EAAOC,QAAU,SAAU6S,EAAQmxD,GACjC,IAGIx0D,EAHAjO,EAAIoB,EAAgBkQ,GACpB1Q,EAAI,EACJsI,EAAS,GAEb,IAAK+E,KAAOjO,GAAIgD,EAAIgR,EAAY/F,IAAQjL,EAAIhD,EAAGiO,IAAQ/E,EAAOnE,KAAKkJ,GAEnE,MAAOw0D,EAAM3jE,OAAS8B,EAAOoC,EAAIhD,EAAGiO,EAAMw0D,EAAM7hE,SAC7C6V,EAAQvN,EAAQ+E,IAAQ/E,EAAOnE,KAAKkJ,IAEvC,OAAO/E,I,kCCdT,IAAI5J,EAAI,EAAQ,QACZktE,EAAY,EAAQ,QAA+Bj2D,SACnDm9C,EAAmB,EAAQ,QAI/Bp0D,EAAE,CAAEM,OAAQ,QAASC,OAAO,GAAQ,CAClC0W,SAAU,SAAkBwkB,GAC1B,OAAOyxC,EAAUvsE,KAAM86B,EAAI17B,UAAUP,OAAS,EAAIO,UAAU,QAAKN,MAKrE20D,EAAiB,a,qBCdjB,IAAIp0D,EAAI,EAAQ,QACZg4D,EAAO,EAAQ,QACf5D,EAAmB,EAAQ,QAI/Bp0D,EAAE,CAAEM,OAAQ,QAASC,OAAO,GAAQ,CAClCy3D,KAAMA,IAIR5D,EAAiB,S,qBCXjB,IAAI3jD,EAAS,EAAQ,QACjB3P,EAAW,EAAQ,QAEnBgqB,EAAWra,EAAOqa,SAElBqiD,EAASrsE,EAASgqB,IAAahqB,EAASgqB,EAAS9jB,eAErD9H,EAAOC,QAAU,SAAUoD,GACzB,OAAO4qE,EAASriD,EAAS9jB,cAAczE,GAAM,K,qBCR/C,IAAIvC,EAAI,EAAQ,QACZksD,EAAS,EAAQ,QAKrBlsD,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,OAAQjP,OAAO8pD,SAAWA,GAAU,CACpEA,OAAQA,K,qBCPV,IAAIjiD,EAAW,EAAQ,QACnBnJ,EAAW,EAAQ,QACnBssE,EAAuB,EAAQ,QAEnCluE,EAAOC,QAAU,SAAU+B,EAAGwhD,GAE5B,GADAz4C,EAAS/I,GACLJ,EAAS4hD,IAAMA,EAAEv/C,cAAgBjC,EAAG,OAAOwhD,EAC/C,IAAI2qB,EAAoBD,EAAqBprE,EAAEd,GAC3CiE,EAAUkoE,EAAkBloE,QAEhC,OADAA,EAAQu9C,GACD2qB,EAAkBpoE,U,qBCV3B,IAAIwL,EAAS,EAAQ,QACjBE,EAA8B,EAAQ,QAE1CzR,EAAOC,QAAU,SAAUwP,EAAKrF,GAC9B,IACEqH,EAA4BF,EAAQ9B,EAAKrF,GACzC,MAAO9G,GACPiO,EAAO9B,GAAOrF,EACd,OAAOA,I,kCCNX,IAAInF,EAAQ,EAAQ,QAChB1C,EAAO,EAAQ,QACf6C,EAAQ,EAAQ,QAChBJ,EAAW,EAAQ,QAQvB,SAASopE,EAAeC,GACtB,IAAI90D,EAAU,IAAInU,EAAMipE,GACpBjlB,EAAW7mD,EAAK6C,EAAMzC,UAAU4C,QAASgU,GAQ7C,OALAtU,EAAMqY,OAAO8rC,EAAUhkD,EAAMzC,UAAW4W,GAGxCtU,EAAMqY,OAAO8rC,EAAU7vC,GAEhB6vC,EAIT,IAAIklB,EAAQF,EAAeppE,GAG3BspE,EAAMlpE,MAAQA,EAGdkpE,EAAMzyD,OAAS,SAAgBxW,GAC7B,OAAO+oE,EAAenpE,EAAMS,MAAMV,EAAUK,KAI9CipE,EAAM5b,OAAS,EAAQ,QACvB4b,EAAMvP,YAAc,EAAQ,QAC5BuP,EAAM9jB,SAAW,EAAQ,QAGzB8jB,EAAMC,IAAM,SAAaC,GACvB,OAAOxoE,QAAQuoE,IAAIC,IAErBF,EAAMG,OAAS,EAAQ,QAEvBzuE,EAAOC,QAAUquE,EAGjBtuE,EAAOC,QAAQ0I,QAAU2lE,G,mBCnDzBtuE,EAAOC,QAAU,I,mBCAjBD,EAAOC,QAAU,SAAUoR,GACzB,IACE,QAASA,IACT,MAAO/N,GACP,OAAO,K,qBCJX,IAAI8c,EAAO,EAAQ,QACf7O,EAAS,EAAQ,QAEjBpR,EAAY,SAAUuuE,GACxB,MAA0B,mBAAZA,EAAyBA,OAAWnuE,GAGpDP,EAAOC,QAAU,SAAU8nC,EAAWniC,GACpC,OAAO/E,UAAUP,OAAS,EAAIH,EAAUigB,EAAK2nB,KAAe5nC,EAAUoR,EAAOw2B,IACzE3nB,EAAK2nB,IAAc3nB,EAAK2nB,GAAWniC,IAAW2L,EAAOw2B,IAAcx2B,EAAOw2B,GAAWniC,K,kCCT3F,gBAUe,qBAAW,CACxB1B,KADwB,eAGxBwC,KAAM,iBAAO,CACXioE,UAAU,IAGZ5pC,QAPwB,WAOjB,WAIL9hC,OAAA,uBAA6B,WAC3B,yCACA,qB,kCCtBN,IAAI6gE,EAAwB,GAAG/b,qBAE3BpjD,EAA2BzB,OAAOyB,yBAGlCiqE,EAAcjqE,IAA6Bm/D,EAAsBtjE,KAAK,CAAEquE,EAAG,GAAK,GAIpF5uE,EAAQ6C,EAAI8rE,EAAc,SAA8B5K,GACtD,IAAIhvD,EAAarQ,EAAyBlD,KAAMuiE,GAChD,QAAShvD,GAAcA,EAAWgL,YAChC8jD,G,qBCbJ,IAAI3B,EAAwB,EAAQ,QAIpCA,EAAsB,a,qBCHtB,IAAIp3D,EAAW,EAAQ,QACnB+jE,EAAqB,EAAQ,QAMjC9uE,EAAOC,QAAUiD,OAAOyuD,iBAAmB,aAAe,GAAK,WAC7D,IAEI9qC,EAFAkoD,GAAiB,EACjBhvE,EAAO,GAEX,IAEE8mB,EAAS3jB,OAAOyB,yBAAyBzB,OAAOP,UAAW,aAAa0f,IACxEwE,EAAOrmB,KAAKT,EAAM,IAClBgvE,EAAiBhvE,aAAgB4D,MACjC,MAAOL,IACT,OAAO,SAAwB9B,EAAGH,GAKhC,OAJA0J,EAASvJ,GACTstE,EAAmBztE,GACf0tE,EAAgBloD,EAAOrmB,KAAKgB,EAAGH,GAC9BG,EAAE2kB,UAAY9kB,EACZG,GAfoD,QAiBzDjB,I,qBCzBN,IAAI+nE,EAAwB,EAAQ,QAChC7zD,EAAW,EAAQ,QACnB1R,EAAW,EAAQ,QAIlBulE,GACH7zD,EAASvR,OAAOP,UAAW,WAAYI,EAAU,CAAEyV,QAAQ,K,qBCP7D,IAAIzQ,EAAiB,EAAQ,QAAuCjF,EAChE0B,EAAM,EAAQ,QACd3E,EAAkB,EAAQ,QAE1BC,EAAgBD,EAAgB,eAEpCG,EAAOC,QAAU,SAAUoD,EAAI2rE,EAAK75D,GAC9B9R,IAAOmB,EAAInB,EAAK8R,EAAS9R,EAAKA,EAAGV,UAAW7C,IAC9CiI,EAAe1E,EAAIvD,EAAe,CAAE6Y,cAAc,EAAMvO,MAAO4kE,M,kCCNnE,EAAQ,QACR,IAAIv6D,EAAW,EAAQ,QACnBtJ,EAAa,EAAQ,QACrBtD,EAAQ,EAAQ,QAChBhI,EAAkB,EAAQ,QAC1B4R,EAA8B,EAAQ,QAEtCyB,EAAUrT,EAAgB,WAC1BsY,EAAkBvL,OAAOjK,UAEzBssE,GAAiCpnE,GAAM,WAIzC,IAAIs4D,EAAK,IAMT,OALAA,EAAG9uD,KAAO,WACR,IAAI3G,EAAS,GAEb,OADAA,EAAOmhD,OAAS,CAAEprD,EAAG,KACdiK,GAEyB,MAA3B,GAAG7D,QAAQs5D,EAAI,WAKpB/U,EAAmB,WAErB,MAAkC,OAA3B,IAAIvkD,QAAQ,IAAK,MAFH,GAKnBokD,EAAUprD,EAAgB,WAE1BsrD,EAA+C,WACjD,QAAI,IAAIF,IAC6B,KAA5B,IAAIA,GAAS,IAAK,MAFsB,GAS/CikB,GAAqCrnE,GAAM,WAE7C,IAAIs4D,EAAK,OACLgP,EAAehP,EAAG9uD,KACtB8uD,EAAG9uD,KAAO,WAAc,OAAO89D,EAAavuE,MAAMa,KAAMZ,YACxD,IAAI6J,EAAS,KAAKmB,MAAMs0D,GACxB,OAAyB,IAAlBz1D,EAAOpK,QAA8B,MAAdoK,EAAO,IAA4B,MAAdA,EAAO,MAG5D1K,EAAOC,QAAU,SAAU2wD,EAAKtwD,EAAQ+Q,EAAMgE,GAC5C,IAAIgtD,EAASxiE,EAAgB+wD,GAEzBwe,GAAuBvnE,GAAM,WAE/B,IAAIrG,EAAI,GAER,OADAA,EAAE6gE,GAAU,WAAc,OAAO,GACZ,GAAd,GAAGzR,GAAKpvD,MAGb6tE,EAAoBD,IAAwBvnE,GAAM,WAEpD,IAAIynE,GAAa,EACbnP,EAAK,IAkBT,MAhBY,UAARvP,IAIFuP,EAAK,GAGLA,EAAGl8D,YAAc,GACjBk8D,EAAGl8D,YAAYiP,GAAW,WAAc,OAAOitD,GAC/CA,EAAG9zD,MAAQ,GACX8zD,EAAGkC,GAAU,IAAIA,IAGnBlC,EAAG9uD,KAAO,WAAiC,OAAnBi+D,GAAa,EAAa,MAElDnP,EAAGkC,GAAQ,KACHiN,KAGV,IACGF,IACAC,GACQ,YAARze,KACCqe,IACA7jB,GACCD,IAEM,UAARyF,IAAoBse,EACrB,CACA,IAAIK,EAAqB,IAAIlN,GACzBxzD,EAAUwC,EAAKgxD,EAAQ,GAAGzR,IAAM,SAAUC,EAAc7jD,EAAQ/F,EAAKuoE,EAAMC,GAC7E,IAAIC,EAAQ1iE,EAAOqE,KACnB,OAAIq+D,IAAUvkE,GAAcukE,IAAUv3D,EAAgB9G,KAChD+9D,IAAwBK,EAInB,CAAEviE,MAAM,EAAM9C,MAAOmlE,EAAmB/uE,KAAKwM,EAAQ/F,EAAKuoE,IAE5D,CAAEtiE,MAAM,EAAM9C,MAAOymD,EAAarwD,KAAKyG,EAAK+F,EAAQwiE,IAEtD,CAAEtiE,MAAM,KACd,CACDk+C,iBAAkBA,EAClBD,6CAA8CA,IAE5CwkB,EAAe9gE,EAAQ,GACvB+gE,EAAc/gE,EAAQ,GAE1B4F,EAASvU,OAAOyC,UAAWiuD,EAAK+e,GAChCl7D,EAAS0D,EAAiBkqD,EAAkB,GAAV/hE,EAG9B,SAAU0L,EAAQyiC,GAAO,OAAOmhC,EAAYpvE,KAAKwL,EAAQvK,KAAMgtC,IAG/D,SAAUziC,GAAU,OAAO4jE,EAAYpvE,KAAKwL,EAAQvK,QAItD4T,GAAM5D,EAA4B0G,EAAgBkqD,GAAS,QAAQ,K,kCC9HzE,IAAIvhE,EAAI,EAAQ,QACZ+uE,EAAO,EAAQ,QAAgCj0D,IAC/C+tC,EAA+B,EAAQ,QAEvCC,EAAsBD,EAA6B,OAKvD7oD,EAAE,CAAEM,OAAQ,QAASC,OAAO,EAAM8Q,QAASy3C,GAAuB,CAChEhuC,IAAK,SAAa5J,GAChB,OAAO69D,EAAKpuE,KAAMuQ,EAAYnR,UAAUP,OAAS,EAAIO,UAAU,QAAKN,O,kCCJxEP,EAAOC,QAAU,SAAuB0F,GAItC,MAAO,gCAAgC5F,KAAK4F,K,4PCT9C,SAASmqE,EAAT,OACE,IAAI,cAAJ,QAUA,GARA,IACEpoD,EAAK,CACHnB,QADG,EAEHiE,QAFG,EAGHxQ,SAAU0N,IAId,EAAQ,CAGN,GADAA,EAAA,gBAAqBA,EAAA,iBAArB,GACIA,EAAA,yBAAJ,GAA0C,OAC1CA,EAAA,wBAGF,MAAO,wBACLA,EAAKqoD,EAAH,GADJ,KAUI,kBACJ,IAAMC,EAAaF,EAAc1vB,EAAS14B,EAA1C,GACA,MAAAsoD,GAAsBjlD,QAAA,KAAtBilD,GAGI,kBACJ,IAAMA,EAAaF,EAAc1vB,EAAS14B,EAA1C,GACA,MAAAsoD,GAAsBjlD,QAAA,MAAtBilD,GAMI,oBACJC,EAAa,eAAD,OAAgB7qD,EAAhB,sLAAZ,GAUF,IAAM8qD,EAAN,kBACMC,EAAY,SAAAlpE,GAAD,OAAiBA,EAAA,WACX,SAAAtG,GAAC,OAAIA,EADM,iCAAlC,KAIA,SAASyvE,EAAT,KACE,GAAI1oD,EAAA,QAAJ,EACE,eAEF,IAAM7T,EAAwB,oBAAP6T,GAAP,MAA4BA,EAAA,IACxCA,EADY,QAEZA,EAAA,OACEA,EAAA,UAAeA,EAAA,YADjB,QAEEA,GAJN,GAKIxjB,EAAO2P,EAAA,MAAgBA,EAA3B,cACMw8D,EAAOx8D,EAAb,OACA,IAAK3P,GAAL,EAAmB,CACjB,IAAMuD,EAAQ4oE,EAAA,MAAd,mBACAnsE,EAAOuD,GAASA,EAAhB,GAGF,OACGvD,EAAO,IAAH,OAAOisE,EAAZ,GAAK,qBACJE,IAAA,IAAQC,EAAR,cAAAD,GAFH,IAMF,SAASN,EAAT,GACE,GAAIroD,EAAA,QAAaA,EAAjB,QAA6B,CAC3B,IAAMmK,EAAN,GACI0+C,EAAJ,EACA,QAAW,CACT,GAAI1+C,EAAA,OAAJ,EAAqB,CACnB,IAAMvD,EAAYuD,EAAKA,EAAA,OAAvB,GACA,GAAIvD,EAAA,cAAqB5G,EAAzB,YAAyC,CACvC6oD,IACA7oD,EAAKA,EAAL,QACA,SACS6oD,EAAJ,IACL1+C,EAAKA,EAAA,OAAL,GAAwB,CAACvD,EAAzB,GACAiiD,EAAA,GAGJ1+C,EAAA,QACAnK,EAAKA,EAAL,QAEF,MAAO,mBAAqBmK,EAAA,KACrB,8BACH,IAAAzvB,EAAA,WAAoB,IAAI2/C,OAAO,EAAX,EAAe3/C,IADhC,OAGHuB,MAAA,qBACOysE,EAAoB1oD,EAAD,IAD1B,gBACyCA,EADzC,wBAEI0oD,EANoB,YAA5B,MAUA,8BAAwBA,EAAxB,U,4KCtGEnsC,EAAU,CACdusC,UADc,gBAEdC,UAAW,SAGb,SAASC,EAAT,GACE,IADgC,EAC1BC,EAAN,GADgC,iBAGhB1gE,EAAA,MAAYg0B,EAA5B,YAHgC,IAGhC,2BAAgD,KAAhD,EAAgD,QAC9C,EAAiB8S,EAAA,MAAQ9S,EAAzB,iCAAI,EAAJ,KAAI,EAAJ,KACAx0B,EAAMA,EAAN,OACA,IAIA,kBAAWjG,IACTA,EAAMA,EAAN,QAEFmnE,EAAS,eAAT,QAb8B,8BAgBhC,SASY,aACZ,IAD+B,EACzBC,EAAN,GACIxuE,EAAYvB,UAAhB,OAIA,MAAOuB,IAGL,cAAac,OAAA,KAAYrC,UAAzB,mBACE,OADF,EAAwC,KACtC,GAEE,YACA,iBACMA,UAAA,GAAJ,KACE+vE,EAAA,GAAoBC,EAAaD,EAAD,GAAoB/vE,UAAA,GAApD,KAEF,MACF,YACMA,UAAA,GAAJ,KACE+vE,EAAA,GAAoBE,EAAYF,EAAD,GAAoB/vE,UAAA,GAAnD,KAEF,MAEF,kBACE,IAAKA,UAAA,GAAL,GACE,WAEF,IAAI+vE,EAAA,KACFA,EAAA,OAEEA,EAAJ,KAEEA,EAAA,SAEFA,EAAA,IAAqB/vE,UAAA,MAArB,OACA,MAMF,SACA,eACMA,UAAA,GAAJ,KACE+vE,EAAA,GAAoBG,EAAeH,EAAD,GAAoB/vE,UAAA,GAAtD,KAEF,MAEF,YACA,YACA,eACA,kBACA,kBACA,WACA,iBACE,IAAKA,UAAA,GAAL,GACE,MAEG+vE,EAAL,KACEA,EAAA,OAEFA,EAAA,oCAAyB/vE,UAAA,GAAL,IAA4B+vE,EAAYlnE,IAC5D,MAEF,QACOknE,EAAL,KACEA,EAAA,GAAoB/vE,UAAA,GAApB,IAMV,SAGI,gBAIJ,SACA,GAEAO,EAAS,eAA8B,kBAAXA,EAAsBsvE,EAA7B,GAArBtvE,GAEQA,EAAA,OAA6C,kBAAXyL,EAAsB6jE,EAA7B,GAAnC,IAJoBtvE,EADAyL,EAQhB,gBACJ,SACA,GAEOzL,EAAS,yBAAH,GAFOyL,EADAzL,EAMhB,aAIJ,8CAAc,OAAO,UAAP,8BACd,8CAAc,OAAO,UAAP,8BAId,IAFA,IAAM4vE,EAAN,GAES5uE,EAAT,EAAgBA,KAAM,CACpB,IAAMqsC,EAAN,EAAS,qBAAT,OAAS,YAAT,GACA,IAAK,IAAL,OACOA,EAAL,KAEIuiC,EAAJ,GAGEA,EAAA,GAAe,UAAyBviC,EAAzB,GAAqCuiC,EAApD,IAGAA,EAAA,GAAcviC,EAAd,IAKN,W,sBC/JF,8BACE,OAAOprC,GAAMA,EAAGuD,MAAQA,MAAQvD,GAIlCrD,EAAOC,QAELgxE,EAA2B,iBAAdC,YAA0BA,aACvCD,EAAuB,iBAAVhuE,QAAsBA,SAEnCguE,EAAqB,iBAARhsB,MAAoBA,OACjCgsB,EAAuB,iBAAV1/D,GAAsBA,IAEnC,WAAe,OAAO9P,KAAtB,IAAoCY,SAAS,cAATA,K,2CCbtC,IAAIvB,EAAI,EAAQ,QACZsD,EAAc,EAAQ,QACtB+d,EAAU,EAAQ,QAClBvf,EAAkB,EAAQ,QAC1Bs/D,EAAiC,EAAQ,QACzCpY,EAAiB,EAAQ,QAI7BhpD,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMsQ,MAAOjR,GAAe,CACtD+nD,0BAA2B,SAAmCr5C,GAC5D,IAKIrD,EAAKuF,EALLxT,EAAIoB,EAAgBkQ,GACpBnO,EAA2Bu9D,EAA+Bp/D,EAC1Dub,EAAO8D,EAAQ3gB,GACfkJ,EAAS,GACToC,EAAQ,EAEZ,MAAOuR,EAAK/d,OAASwM,EACnBkI,EAAarQ,EAAyBnD,EAAGiO,EAAM4O,EAAKvR,WACjCvM,IAAfyU,GAA0B80C,EAAep/C,EAAQ+E,EAAKuF,GAE5D,OAAOtK,M,qBCrBX,IAAI5J,EAAI,EAAQ,QACZqwE,EAAW,EAAQ,QACnBtpE,EAAQ,EAAQ,QAChBjG,EAAW,EAAQ,QACnBwvE,EAAW,EAAQ,QAAkCA,SAGrDC,EAAUnuE,OAAOsX,OACjBymC,EAAsBp5C,GAAM,WAAcwpE,EAAQ,MAItDvwE,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,OAAQ8uC,EAAqB5rC,MAAO87D,GAAY,CAChF32D,OAAQ,SAAgBnX,GACtB,OAAOguE,GAAWzvE,EAASyB,GAAMguE,EAAQD,EAAS/tE,IAAOA,M,qBCd7D,IAAIkO,EAAS,EAAQ,QACjBC,EAAe,EAAQ,QACvB8/D,EAAuB,EAAQ,QAC/B7/D,EAA8B,EAAQ,QACtC5R,EAAkB,EAAQ,QAE1B0S,EAAW1S,EAAgB,YAC3BC,EAAgBD,EAAgB,eAChC0xE,EAAcD,EAAqBxsE,OAEvC,IAAK,IAAI4M,KAAmBF,EAAc,CACxC,IAAIG,EAAaJ,EAAOG,GACpBE,EAAsBD,GAAcA,EAAWhP,UACnD,GAAIiP,EAAqB,CAEvB,GAAIA,EAAoBW,KAAcg/D,EAAa,IACjD9/D,EAA4BG,EAAqBW,EAAUg/D,GAC3D,MAAOjuE,GACPsO,EAAoBW,GAAYg/D,EAKlC,GAHK3/D,EAAoB9R,IACvB2R,EAA4BG,EAAqB9R,EAAe4R,GAE9DF,EAAaE,GAAkB,IAAK,IAAIyB,KAAem+D,EAEzD,GAAI1/D,EAAoBuB,KAAiBm+D,EAAqBn+D,GAAc,IAC1E1B,EAA4BG,EAAqBuB,EAAam+D,EAAqBn+D,IACnF,MAAO7P,GACPsO,EAAoBuB,GAAem+D,EAAqBn+D,O,qBC5BhE,IAAImC,EAAqB,EAAQ,QAC7BC,EAAc,EAAQ,QAK1BvV,EAAOC,QAAUiD,OAAOmb,MAAQ,SAAc7c,GAC5C,OAAO8T,EAAmB9T,EAAG+T,K,yDCJ/B,IAAIzU,EAAI,EAAQ,QACZsD,EAAc,EAAQ,QACtBmN,EAAS,EAAQ,QACjB/M,EAAM,EAAQ,QACd5C,EAAW,EAAQ,QACnBmG,EAAiB,EAAQ,QAAuCjF,EAChE6R,EAA4B,EAAQ,QAEpC68D,EAAejgE,EAAO0Q,OAE1B,GAAI7d,GAAsC,mBAAhBotE,MAAiC,gBAAiBA,EAAa7uE,iBAExDpC,IAA/BixE,IAAe/N,aACd,CACD,IAAIgO,EAA8B,GAE9BC,EAAgB,WAClB,IAAIjO,EAAc5iE,UAAUP,OAAS,QAAsBC,IAAjBM,UAAU,QAAmBN,EAAYL,OAAOW,UAAU,IAChG6J,EAASjJ,gBAAgBiwE,EACzB,IAAIF,EAAa/N,QAEDljE,IAAhBkjE,EAA4B+N,IAAiBA,EAAa/N,GAE9D,MADoB,KAAhBA,IAAoBgO,EAA4B/mE,IAAU,GACvDA,GAETiK,EAA0B+8D,EAAeF,GACzC,IAAIG,EAAkBD,EAAc/uE,UAAY6uE,EAAa7uE,UAC7DgvE,EAAgB1tE,YAAcytE,EAE9B,IAAIE,EAAiBD,EAAgB5uE,SACjC8uE,EAAyC,gBAAhC3xE,OAAOsxE,EAAa,SAC7BxkE,EAAS,wBACbjF,EAAe4pE,EAAiB,cAAe,CAC7Ch5D,cAAc,EACd3Q,IAAK,WACH,IAAI0qB,EAAS9wB,EAASH,MAAQA,KAAK+iE,UAAY/iE,KAC3CuK,EAAS4lE,EAAepxE,KAAKkyB,GACjC,GAAIluB,EAAIitE,EAA6B/+C,GAAS,MAAO,GACrD,IAAIo/C,EAAOD,EAAS7lE,EAAOnK,MAAM,GAAI,GAAKmK,EAAOnF,QAAQmG,EAAQ,MACjE,MAAgB,KAAT8kE,OAAcvxE,EAAYuxE,KAIrChxE,EAAE,CAAEyQ,QAAQ,EAAMY,QAAQ,GAAQ,CAChC8P,OAAQyvD,M,qBC/CZ,IAAIltE,EAAM,EAAQ,QACdxD,EAAW,EAAQ,QACnByuD,EAAY,EAAQ,QACpBzO,EAA2B,EAAQ,QAEnCgT,EAAWvE,EAAU,YACrB8S,EAAkBr/D,OAAOP,UAK7B3C,EAAOC,QAAU+gD,EAA2B99C,OAAOg+C,eAAiB,SAAU1/C,GAE5E,OADAA,EAAIR,EAASQ,GACTgD,EAAIhD,EAAGwyD,GAAkBxyD,EAAEwyD,GACH,mBAAjBxyD,EAAEyC,aAA6BzC,aAAaA,EAAEyC,YAChDzC,EAAEyC,YAAYtB,UACdnB,aAAa0B,OAASq/D,EAAkB,O,qBChBnD,IAAI16D,EAAQ,EAAQ,QAEpB7H,EAAOC,SAAW4H,GAAM,WACtB,SAASkhD,KAGT,OAFAA,EAAEpmD,UAAUsB,YAAc,KAEnBf,OAAOg+C,eAAe,IAAI6H,KAASA,EAAEpmD,c,kCCL9C,IAAIC,EAAkB,EAAQ,QAC1BsyD,EAAmB,EAAQ,QAC3B/T,EAAY,EAAQ,QACpBwB,EAAsB,EAAQ,QAC9BC,EAAiB,EAAQ,QAEzBmvB,EAAiB,iBACjBjvB,EAAmBH,EAAoBtgC,IACvC0gC,EAAmBJ,EAAoBK,UAAU+uB,GAYrD/xE,EAAOC,QAAU2iD,EAAej/C,MAAO,SAAS,SAAUs/C,EAAUmM,GAClEtM,EAAiBrhD,KAAM,CACrBiH,KAAMqpE,EACN3wE,OAAQwB,EAAgBqgD,GACxBn2C,MAAO,EACPsiD,KAAMA,OAIP,WACD,IAAIjM,EAAQJ,EAAiBthD,MACzBL,EAAS+hD,EAAM/hD,OACfguD,EAAOjM,EAAMiM,KACbtiD,EAAQq2C,EAAMr2C,QAClB,OAAK1L,GAAU0L,GAAS1L,EAAOd,QAC7B6iD,EAAM/hD,YAASb,EACR,CAAE6J,WAAO7J,EAAW2M,MAAM,IAEvB,QAARkiD,EAAuB,CAAEhlD,MAAO0C,EAAOI,MAAM,GACrC,UAARkiD,EAAyB,CAAEhlD,MAAOhJ,EAAO0L,GAAQI,MAAM,GACpD,CAAE9C,MAAO,CAAC0C,EAAO1L,EAAO0L,IAASI,MAAM,KAC7C,UAKHi0C,EAAU6wB,UAAY7wB,EAAUx9C,MAGhCuxD,EAAiB,QACjBA,EAAiB,UACjBA,EAAiB,Y,qBCpDjB,IAAIzgD,EAAW,EAAQ,QAEvBzU,EAAOC,QAAU,SAAUmB,EAAQ8kB,EAAKrS,GACtC,IAAK,IAAIpE,KAAOyW,EAAKzR,EAASrT,EAAQqO,EAAKyW,EAAIzW,GAAMoE,GACrD,OAAOzS,I,qBCJT,IAAIN,EAAI,EAAQ,QACZ+G,EAAQ,EAAQ,QAChBjF,EAAkB,EAAQ,QAC1B8/D,EAAiC,EAAQ,QAAmD5/D,EAC5FsB,EAAc,EAAQ,QAEtB68C,EAAsBp5C,GAAM,WAAc66D,EAA+B,MACzE7tD,GAAUzQ,GAAe68C,EAI7BngD,EAAE,CAAEM,OAAQ,SAAU2D,MAAM,EAAMoN,OAAQ0C,EAAQQ,MAAOjR,GAAe,CACtEO,yBAA0B,SAAkCtB,EAAIoM,GAC9D,OAAOizD,EAA+B9/D,EAAgBS,GAAKoM,O,qBCb/D,IAAI5P,EAAkB,EAAQ,QAE9BI,EAAQ6C,EAAIjD,G,mBCFZG,EAAOC,QAAU,SAAUoR,GACzB,IACE,MAAO,CAAE/N,OAAO,EAAO8G,MAAOiH,KAC9B,MAAO/N,GACP,MAAO,CAAEA,OAAO,EAAM8G,MAAO9G,M,kCCKjCtD,EAAOC,QAAU,SAAqB6qD,EAASmnB,GAC7C,OAAOA,EACHnnB,EAAQjkD,QAAQ,OAAQ,IAAM,IAAMorE,EAAYprE,QAAQ,OAAQ,IAChEikD,I,kCCXN,IAqDIonB,EAAUC,EAAsBC,EAAgBC,EArDhDvxE,EAAI,EAAQ,QACZw9C,EAAU,EAAQ,QAClB/sC,EAAS,EAAQ,QACjBe,EAAa,EAAQ,QACrBsyD,EAAgB,EAAQ,QACxBnwD,EAAW,EAAQ,QACnBy5C,EAAc,EAAQ,QACtByD,EAAiB,EAAQ,QACzBtB,EAAiB,EAAQ,QACzBhC,EAAa,EAAQ,QACrBzsD,EAAW,EAAQ,QACnBzB,EAAY,EAAQ,QACpBguD,EAAa,EAAQ,QACrBmD,EAAgB,EAAQ,QACxBlD,EAAU,EAAQ,QAClBgC,EAA8B,EAAQ,QACtCplD,EAAqB,EAAQ,QAC7BigE,EAAO,EAAQ,QAAqB5oD,IACpCiwD,EAAY,EAAQ,QACpBzN,EAAiB,EAAQ,QACzB0N,EAAmB,EAAQ,QAC3BC,EAA6B,EAAQ,QACrCC,EAAU,EAAQ,QAClB9vB,EAAsB,EAAQ,QAC9B/tC,EAAW,EAAQ,QACnB/U,EAAkB,EAAQ,QAC1B6yE,EAAa,EAAQ,QACrBzzB,EAAU,EAAQ,QAClBhsC,EAAa,EAAQ,QAErBC,EAAUrT,EAAgB,WAC1B8yE,EAAU,UACV5vB,EAAmBJ,EAAoB36C,IACvC86C,EAAmBH,EAAoBtgC,IACvCuwD,EAA0BjwB,EAAoBK,UAAU2vB,GACxDE,EAAyBjO,GAAiBA,EAAcjiE,UACxDmwE,EAAqBlO,EACrBmO,EAA8BF,EAC9BvhE,EAAYC,EAAOD,UACnBsa,EAAWra,EAAOqa,SAClB3V,EAAU1E,EAAO0E,QACjBi4D,EAAuBsE,EAA2B1vE,EAClDkwE,EAA8B9E,EAC9B+E,KAAoBrnD,GAAYA,EAASoS,aAAezsB,EAAOspC,eAC/Dq4B,EAAyD,mBAAzBC,sBAChCC,EAAsB,qBACtBC,EAAoB,mBACpBC,EAAU,EACVC,GAAY,EACZC,GAAW,EACXC,GAAU,EACVC,GAAY,EACZC,IAAc,EAGd9+D,GAASD,EAAS+9D,GAAS,WAC7B,IAAIiB,EAAyBtiB,EAAcwhB,KAAwB5yE,OAAO4yE,GAI1E,IAAKc,GAAyC,KAAf3gE,EAAmB,OAAO,EAEzD,GAAIqrC,IAAYy0B,EAA4B,WAAY,OAAO,EAI/D,GAAI9/D,GAAc,IAAM,cAAclT,KAAK+yE,GAAqB,OAAO,EAEvE,IAAI/sE,EAAU,IAAI+sE,GAAmB,SAAU7sE,GAAWA,EAAQ,MAC9D4tE,EAAc,SAAUxiE,GAC1BA,GAAK,eAA6B,gBAEhCpN,EAAc8B,EAAQ9B,YAAc,GAGxC,OAFAA,EAAYiP,GAAW2gE,EACvBF,GAAc5tE,EAAQS,MAAK,yBAAwCqtE,GAC9DF,KAEGC,GAA0BlB,IAAeQ,KAG/CxO,GAAsB7vD,KAAWu7C,GAA4B,SAAUz8C,GACzEm/D,EAAmBvE,IAAI56D,GAAU,UAAS,kBAIxCmgE,GAAa,SAAUzwE,GACzB,IAAImD,EACJ,SAAO5E,EAASyB,IAAkC,mBAAnBmD,EAAOnD,EAAGmD,QAAsBA,GAG7Dyc,GAAS,SAAUkgC,EAAO4wB,GAC5B,IAAI5wB,EAAM6wB,SAAV,CACA7wB,EAAM6wB,UAAW,EACjB,IAAIluE,EAAQq9C,EAAM8wB,UAClB3B,GAAU,WACR,IAAIloE,EAAQ+4C,EAAM/4C,MACd8pE,EAAK/wB,EAAMA,OAASowB,GACpBzmE,EAAQ,EAEZ,MAAOhH,EAAMxF,OAASwM,EAAO,CAC3B,IAKIpC,EAAQlE,EAAM2tE,EALdC,EAAWtuE,EAAMgH,KACjB8d,EAAUspD,EAAKE,EAASF,GAAKE,EAASC,KACtCpuE,EAAUmuE,EAASnuE,QACnB8zB,EAASq6C,EAASr6C,OAClB84B,EAASuhB,EAASvhB,OAEtB,IACMjoC,GACGspD,IACC/wB,EAAMmxB,YAAcZ,IAAWa,GAAkBpxB,GACrDA,EAAMmxB,UAAYb,KAEJ,IAAZ7oD,EAAkBlgB,EAASN,GAEzByoD,GAAQA,EAAO7b,QACnBtsC,EAASkgB,EAAQxgB,GACbyoD,IACFA,EAAOmY,OACPmJ,GAAS,IAGTzpE,IAAW0pE,EAASruE,QACtBg0B,EAAOzoB,EAAU,yBACR9K,EAAOstE,GAAWppE,IAC3BlE,EAAKhG,KAAKkK,EAAQzE,EAAS8zB,GACtB9zB,EAAQyE,IACVqvB,EAAO3vB,GACd,MAAO9G,GACHuvD,IAAWshB,GAAQthB,EAAOmY,OAC9BjxC,EAAOz2B,IAGX6/C,EAAM8wB,UAAY,GAClB9wB,EAAM6wB,UAAW,EACbD,IAAa5wB,EAAMmxB,WAAWE,GAAYrxB,QAI9CtI,GAAgB,SAAU32C,EAAM6B,EAASi0B,GAC3C,IAAI3M,EAAOzC,EACPqoD,GACF5lD,EAAQzB,EAASoS,YAAY,SAC7B3Q,EAAMtnB,QAAUA,EAChBsnB,EAAM2M,OAASA,EACf3M,EAAMutB,UAAU12C,GAAM,GAAO,GAC7BqN,EAAOspC,cAAcxtB,IAChBA,EAAQ,CAAEtnB,QAASA,EAASi0B,OAAQA,IACtCk5C,IAA2BtoD,EAAUrZ,EAAO,KAAOrN,IAAQ0mB,EAAQyC,GAC/DnpB,IAASkvE,GAAqBb,EAAiB,8BAA+Bv4C,IAGrFw6C,GAAc,SAAUrxB,GAC1B8nB,EAAKzqE,KAAK+Q,GAAQ,WAChB,IAGI7G,EAHA3E,EAAUo9C,EAAM8M,OAChB7lD,EAAQ+4C,EAAM/4C,MACdqqE,EAAeC,GAAYvxB,GAE/B,GAAIsxB,IACF/pE,EAAS+nE,GAAQ,WACXxzB,EACFhpC,EAAQyoB,KAAK,qBAAsBt0B,EAAOrE,GACrC80C,GAAcu4B,EAAqBrtE,EAASqE,MAGrD+4C,EAAMmxB,UAAYr1B,GAAWy1B,GAAYvxB,GAASuwB,GAAYD,GAC1D/oE,EAAOpH,OAAO,MAAMoH,EAAON,UAKjCsqE,GAAc,SAAUvxB,GAC1B,OAAOA,EAAMmxB,YAAcb,KAAYtwB,EAAMzpC,QAG3C66D,GAAoB,SAAUpxB,GAChC8nB,EAAKzqE,KAAK+Q,GAAQ,WAChB,IAAIxL,EAAUo9C,EAAM8M,OAChBhR,EACFhpC,EAAQyoB,KAAK,mBAAoB34B,GAC5B80C,GAAcw4B,EAAmBttE,EAASo9C,EAAM/4C,WAIvD7H,GAAO,SAAUnC,EAAI+iD,EAAOwxB,GAC9B,OAAO,SAAUvqE,GACfhK,EAAG+iD,EAAO/4C,EAAOuqE,KAIjBC,GAAiB,SAAUzxB,EAAO/4C,EAAOuqE,GACvCxxB,EAAMj2C,OACVi2C,EAAMj2C,MAAO,EACTynE,IAAQxxB,EAAQwxB,GACpBxxB,EAAM/4C,MAAQA,EACd+4C,EAAMA,MAAQqwB,GACdvwD,GAAOkgC,GAAO,KAGZ0xB,GAAkB,SAAU1xB,EAAO/4C,EAAOuqE,GAC5C,IAAIxxB,EAAMj2C,KAAV,CACAi2C,EAAMj2C,MAAO,EACTynE,IAAQxxB,EAAQwxB,GACpB,IACE,GAAIxxB,EAAM8M,SAAW7lD,EAAO,MAAMkH,EAAU,oCAC5C,IAAI9K,EAAOstE,GAAW1pE,GAClB5D,EACF8rE,GAAU,WACR,IAAI7jB,EAAU,CAAEvhD,MAAM,GACtB,IACE1G,EAAKhG,KAAK4J,EACR7H,GAAKsyE,GAAiBpmB,EAAStL,GAC/B5gD,GAAKqyE,GAAgBnmB,EAAStL,IAEhC,MAAO7/C,GACPsxE,GAAenmB,EAASnrD,EAAO6/C,QAInCA,EAAM/4C,MAAQA,EACd+4C,EAAMA,MAAQowB,GACdtwD,GAAOkgC,GAAO,IAEhB,MAAO7/C,GACPsxE,GAAe,CAAE1nE,MAAM,GAAS5J,EAAO6/C,MAK3C,GAAItuC,KAEFi+D,EAAqB,SAAiB9T,GACpC7Q,EAAW1sD,KAAMqxE,EAAoBH,GACrCxyE,EAAU6+D,GACVkT,EAAS1xE,KAAKiB,MACd,IAAI0hD,EAAQJ,EAAiBthD,MAC7B,IACEu9D,EAASz8D,GAAKsyE,GAAiB1xB,GAAQ5gD,GAAKqyE,GAAgBzxB,IAC5D,MAAO7/C,GACPsxE,GAAezxB,EAAO7/C,KAG1ByvE,EAA8BD,EAAmBnwE,UAEjDuvE,EAAW,SAAiBlT,GAC1Blc,EAAiBrhD,KAAM,CACrBiH,KAAMiqE,EACNzlE,MAAM,EACN8mE,UAAU,EACVt6D,QAAQ,EACRu6D,UAAW,GACXK,WAAW,EACXnxB,MAAOmwB,EACPlpE,WAAO7J,KAGX2xE,EAASvvE,UAAYurD,EAAY6kB,EAA6B,CAG5DvsE,KAAM,SAAcsuE,EAAaC,GAC/B,IAAI5xB,EAAQyvB,EAAwBnxE,MAChC2yE,EAAWlG,EAAqBljE,EAAmBvJ,KAAMqxE,IAO7D,OANAsB,EAASF,GAA2B,mBAAfY,GAA4BA,EACjDV,EAASC,KAA4B,mBAAdU,GAA4BA,EACnDX,EAASvhB,OAAS5T,EAAUhpC,EAAQ48C,YAAStyD,EAC7C4iD,EAAMzpC,QAAS,EACfypC,EAAM8wB,UAAU1tE,KAAK6tE,GACjBjxB,EAAMA,OAASmwB,GAASrwD,GAAOkgC,GAAO,GACnCixB,EAASruE,SAIlB,MAAS,SAAUgvE,GACjB,OAAOtzE,KAAK+E,UAAKjG,EAAWw0E,MAGhC5C,EAAuB,WACrB,IAAIpsE,EAAU,IAAImsE,EACd/uB,EAAQJ,EAAiBh9C,GAC7BtE,KAAKsE,QAAUA,EACftE,KAAKwE,QAAU1D,GAAKsyE,GAAiB1xB,GACrC1hD,KAAKs4B,OAASx3B,GAAKqyE,GAAgBzxB,IAErCqvB,EAA2B1vE,EAAIorE,EAAuB,SAAUlsE,GAC9D,OAAOA,IAAM8wE,GAAsB9wE,IAAMowE,EACrC,IAAID,EAAqBnwE,GACzBgxE,EAA4BhxE,KAG7Bs8C,GAAmC,mBAAjBsmB,GAA+BiO,IAA2B3vE,OAAOP,WAAW,CACjG0vE,EAAaQ,EAAuBrsE,KAE/BmtE,KAEHl/D,EAASo+D,EAAwB,QAAQ,SAAciC,EAAaC,GAClE,IAAI10E,EAAOoB,KACX,OAAO,IAAIqxE,GAAmB,SAAU7sE,EAAS8zB,GAC/Cs4C,EAAW7xE,KAAKH,EAAM4F,EAAS8zB,MAC9BvzB,KAAKsuE,EAAaC,KAEpB,CAAEv8D,QAAQ,IAGb/D,EAASo+D,EAAwB,QAASE,EAA4B,SAAU,CAAEv6D,QAAQ,KAI5F,WACSq6D,EAAuB5uE,YAC9B,MAAOX,KAGLquD,GACFA,EAAekhB,EAAwBE,GAK7CjyE,EAAE,CAAEyQ,QAAQ,EAAMiyD,MAAM,EAAMrxD,OAAQ0C,IAAU,CAC9C7O,QAAS8sE,IAGXziB,EAAeyiB,EAAoBH,GAAS,GAAO,GACnDtkB,EAAWskB,GAEXP,EAAiB9/D,EAAWqgE,GAG5B7xE,EAAE,CAAEM,OAAQuxE,EAAS5tE,MAAM,EAAMoN,OAAQ0C,IAAU,CAGjDklB,OAAQ,SAAgBk/B,GACtB,IAAI+b,EAAa9G,EAAqBzsE,MAEtC,OADAuzE,EAAWj7C,OAAOv5B,UAAKD,EAAW04D,GAC3B+b,EAAWjvE,WAItBjF,EAAE,CAAEM,OAAQuxE,EAAS5tE,MAAM,EAAMoN,OAAQmsC,GAAWzpC,IAAU,CAG5D5O,QAAS,SAAiBu9C,GACxB,OAAOqhB,EAAevmB,GAAW78C,OAAS2wE,EAAiBU,EAAqBrxE,KAAM+hD,MAI1F1iD,EAAE,CAAEM,OAAQuxE,EAAS5tE,MAAM,EAAMoN,OAAQuyD,IAAuB,CAG9D6J,IAAK,SAAa56D,GAChB,IAAI3R,EAAIP,KACJuzE,EAAa9G,EAAqBlsE,GAClCiE,EAAU+uE,EAAW/uE,QACrB8zB,EAASi7C,EAAWj7C,OACpBrvB,EAAS+nE,GAAQ,WACnB,IAAIwC,EAAkB90E,EAAU6B,EAAEiE,SAC9BnB,EAAS,GACT2mB,EAAU,EACVypD,EAAY,EAChB9mB,EAAQz6C,GAAU,SAAU5N,GAC1B,IAAI+G,EAAQ2e,IACR0pD,GAAgB,EACpBrwE,EAAOyB,UAAKhG,GACZ20E,IACAD,EAAgBz0E,KAAKwB,EAAG+D,GAASS,MAAK,SAAU4D,GAC1C+qE,IACJA,GAAgB,EAChBrwE,EAAOgI,GAAS1C,IACd8qE,GAAajvE,EAAQnB,MACtBi1B,QAEHm7C,GAAajvE,EAAQnB,MAGzB,OADI4F,EAAOpH,OAAOy2B,EAAOrvB,EAAON,OACzB4qE,EAAWjvE,SAIpBqvE,KAAM,SAAczhE,GAClB,IAAI3R,EAAIP,KACJuzE,EAAa9G,EAAqBlsE,GAClC+3B,EAASi7C,EAAWj7C,OACpBrvB,EAAS+nE,GAAQ,WACnB,IAAIwC,EAAkB90E,EAAU6B,EAAEiE,SAClCmoD,EAAQz6C,GAAU,SAAU5N,GAC1BkvE,EAAgBz0E,KAAKwB,EAAG+D,GAASS,KAAKwuE,EAAW/uE,QAAS8zB,SAI9D,OADIrvB,EAAOpH,OAAOy2B,EAAOrvB,EAAON,OACzB4qE,EAAWjvE,Y,qBCrYtB,IAAIvB,EAAM,EAAQ,QACd2d,EAAU,EAAQ,QAClB+/C,EAAiC,EAAQ,QACzCzpD,EAAuB,EAAQ,QAEnCzY,EAAOC,QAAU,SAAUmB,EAAQyL,GAIjC,IAHA,IAAIwR,EAAO8D,EAAQtV,GACf9E,EAAiB0Q,EAAqB3V,EACtC6B,EAA2Bu9D,EAA+Bp/D,EACrDV,EAAI,EAAGA,EAAIic,EAAK/d,OAAQ8B,IAAK,CACpC,IAAIqN,EAAM4O,EAAKjc,GACVoC,EAAIpD,EAAQqO,IAAM1H,EAAe3G,EAAQqO,EAAK9K,EAAyBkI,EAAQ4C,O,qBCXxF,IAAI0B,EAAU,EAAQ,QAKtBnR,EAAOC,QAAU0D,MAAM4X,SAAW,SAAiBkzB,GACjD,MAAuB,SAAhBt9B,EAAQs9B,K,qBCNjB,IAAI5uC,EAAkB,EAAQ,QAC1BshD,EAAY,EAAQ,QAEpB5uC,EAAW1S,EAAgB,YAC3BooD,EAAiBtkD,MAAMhB,UAG3B3C,EAAOC,QAAU,SAAUoD,GACzB,YAAc9C,IAAP8C,IAAqB89C,EAAUx9C,QAAUN,GAAM4kD,EAAe11C,KAAclP,K,kCCPrF,IAAIlD,EAAY,EAAQ,QAEpBk1E,EAAoB,SAAUrzE,GAChC,IAAIiE,EAAS8zB,EACbt4B,KAAKsE,QAAU,IAAI/D,GAAE,SAAUszE,EAAWC,GACxC,QAAgBh1E,IAAZ0F,QAAoC1F,IAAXw5B,EAAsB,MAAMzoB,UAAU,2BACnErL,EAAUqvE,EACVv7C,EAASw7C,KAEX9zE,KAAKwE,QAAU9F,EAAU8F,GACzBxE,KAAKs4B,OAAS55B,EAAU45B,IAI1B/5B,EAAOC,QAAQ6C,EAAI,SAAUd,GAC3B,OAAO,IAAIqzE,EAAkBrzE,K,qBChB/B,IAAIwT,EAAa,EAAQ,QACrB5T,EAAW,EAAQ,QACnB4C,EAAM,EAAQ,QACduD,EAAiB,EAAQ,QAAuCjF,EAChE0f,EAAM,EAAQ,QACd2uD,EAAW,EAAQ,QAEnBqE,EAAWhzD,EAAI,QACfE,EAAK,EAGL4D,EAAepjB,OAAOojB,cAAgB,WACxC,OAAO,GAGLmvD,EAAc,SAAUpyE,GAC1B0E,EAAe1E,EAAImyE,EAAU,CAAEprE,MAAO,CACpCsrE,SAAU,OAAQhzD,EAClBizD,SAAU,OAIVrnB,EAAU,SAAUjrD,EAAIwY,GAE1B,IAAKja,EAASyB,GAAK,MAAoB,iBAANA,EAAiBA,GAAmB,iBAANA,EAAiB,IAAM,KAAOA,EAC7F,IAAKmB,EAAInB,EAAImyE,GAAW,CAEtB,IAAKlvD,EAAajjB,GAAK,MAAO,IAE9B,IAAKwY,EAAQ,MAAO,IAEpB45D,EAAYpyE,GAEZ,OAAOA,EAAGmyE,GAAUE,UAGpBE,EAAc,SAAUvyE,EAAIwY,GAC9B,IAAKrX,EAAInB,EAAImyE,GAAW,CAEtB,IAAKlvD,EAAajjB,GAAK,OAAO,EAE9B,IAAKwY,EAAQ,OAAO,EAEpB45D,EAAYpyE,GAEZ,OAAOA,EAAGmyE,GAAUG,UAIpBvE,EAAW,SAAU/tE,GAEvB,OADI8tE,GAAY0E,EAAK9kB,UAAYzqC,EAAajjB,KAAQmB,EAAInB,EAAImyE,IAAWC,EAAYpyE,GAC9EA,GAGLwyE,EAAO71E,EAAOC,QAAU,CAC1B8wD,UAAU,EACVzC,QAASA,EACTsnB,YAAaA,EACbxE,SAAUA,GAGZ57D,EAAWggE,IAAY,G,mBC5DvB,IAOIM,EACAC,EARA9/D,EAAUjW,EAAOC,QAAU,GAU/B,SAAS+1E,IACL,MAAM,IAAI11B,MAAM,mCAEpB,SAAS21B,IACL,MAAM,IAAI31B,MAAM,qCAsBpB,SAAS41B,EAAWC,GAChB,GAAIL,IAAqBxqD,WAErB,OAAOA,WAAW6qD,EAAK,GAG3B,IAAKL,IAAqBE,IAAqBF,IAAqBxqD,WAEhE,OADAwqD,EAAmBxqD,WACZA,WAAW6qD,EAAK,GAE3B,IAEI,OAAOL,EAAiBK,EAAK,GAC/B,MAAM3oE,GACJ,IAEI,OAAOsoE,EAAiBt1E,KAAK,KAAM21E,EAAK,GAC1C,MAAM3oE,GAEJ,OAAOsoE,EAAiBt1E,KAAKiB,KAAM00E,EAAK,KAMpD,SAASC,EAAgBC,GACrB,GAAIN,IAAuBj8C,aAEvB,OAAOA,aAAau8C,GAGxB,IAAKN,IAAuBE,IAAwBF,IAAuBj8C,aAEvE,OADAi8C,EAAqBj8C,aACdA,aAAau8C,GAExB,IAEI,OAAON,EAAmBM,GAC5B,MAAO7oE,GACL,IAEI,OAAOuoE,EAAmBv1E,KAAK,KAAM61E,GACvC,MAAO7oE,GAGL,OAAOuoE,EAAmBv1E,KAAKiB,KAAM40E,MAjEhD,WACG,IAEQP,EADsB,oBAAfxqD,WACYA,WAEA0qD,EAEzB,MAAOxoE,GACLsoE,EAAmBE,EAEvB,IAEQD,EADwB,oBAAjBj8C,aACcA,aAEAm8C,EAE3B,MAAOzoE,GACLuoE,EAAqBE,IAjB7B,GAwEA,IAEIK,EAFA94C,EAAQ,GACR+4C,GAAW,EAEXC,GAAc,EAElB,SAASC,IACAF,GAAaD,IAGlBC,GAAW,EACPD,EAAah2E,OACbk9B,EAAQ84C,EAAa5zE,OAAO86B,GAE5Bg5C,GAAc,EAEdh5C,EAAMl9B,QACNo2E,KAIR,SAASA,IACL,IAAIH,EAAJ,CAGA,IAAIv/D,EAAUk/D,EAAWO,GACzBF,GAAW,EAEX,IAAI9yE,EAAM+5B,EAAMl9B,OAChB,MAAMmD,EAAK,CACP6yE,EAAe94C,EACfA,EAAQ,GACR,QAASg5C,EAAa/yE,EACd6yE,GACAA,EAAaE,GAAYn4C,MAGjCm4C,GAAc,EACd/yE,EAAM+5B,EAAMl9B,OAEhBg2E,EAAe,KACfC,GAAW,EACXH,EAAgBp/D,IAiBpB,SAAS2/D,EAAKR,EAAK/iE,GACf3R,KAAK00E,IAAMA,EACX10E,KAAK2R,MAAQA,EAYjB,SAASqK,KA5BTxH,EAAQ8V,SAAW,SAAUoqD,GACzB,IAAIj0E,EAAO,IAAIyB,MAAM9C,UAAUP,OAAS,GACxC,GAAIO,UAAUP,OAAS,EACnB,IAAK,IAAI8B,EAAI,EAAGA,EAAIvB,UAAUP,OAAQ8B,IAClCF,EAAKE,EAAI,GAAKvB,UAAUuB,GAGhCo7B,EAAMj3B,KAAK,IAAIowE,EAAKR,EAAKj0E,IACJ,IAAjBs7B,EAAMl9B,QAAiBi2E,GACvBL,EAAWQ,IASnBC,EAAKh0E,UAAU07B,IAAM,WACjB58B,KAAK00E,IAAIv1E,MAAM,KAAMa,KAAK2R,QAE9B6C,EAAQ2gE,MAAQ,UAChB3gE,EAAQ4gE,SAAU,EAClB5gE,EAAQyL,IAAM,GACdzL,EAAQ6gE,KAAO,GACf7gE,EAAQwvB,QAAU,GAClBxvB,EAAQgqC,SAAW,GAInBhqC,EAAQpG,GAAK4N,EACbxH,EAAQ8gE,YAAct5D,EACtBxH,EAAQuI,KAAOf,EACfxH,EAAQ+gE,IAAMv5D,EACdxH,EAAQghE,eAAiBx5D,EACzBxH,EAAQihE,mBAAqBz5D,EAC7BxH,EAAQyoB,KAAOjhB,EACfxH,EAAQkhE,gBAAkB15D,EAC1BxH,EAAQmhE,oBAAsB35D,EAE9BxH,EAAQke,UAAY,SAAUjwB,GAAQ,MAAO,IAE7C+R,EAAQ6jC,QAAU,SAAU51C,GACxB,MAAM,IAAIo8C,MAAM,qCAGpBrqC,EAAQohE,IAAM,WAAc,MAAO,KACnCphE,EAAQqhE,MAAQ,SAAUtpC,GACtB,MAAM,IAAIsS,MAAM,mCAEpBrqC,EAAQshE,MAAQ,WAAa,OAAO,I,gGClL9B,aAAkD,MAA/B7tE,EAA+B,uDAAlD,QAAmC2jB,EAAe,uDAAlD,QACJ,OAAO,cAAW,CAChBnpB,KADgB,aAGhBsyB,MAAO,CAAE9sB,OAAM2jB,SAEfhlB,MAAO,kBACL,EAAQ,CAAEiG,UAAU,IAGtB5H,KATgB,WAUd,MAAO,CACLq/C,WAAYtkD,KAAKiI,KAIrB2X,OAAK,sBACH,GADG,SACH,GACE5f,KAAA,gBAFC,sCAIK,KACN,IAAUA,KAAV,IAAwBA,KAAKw5B,MAAM5N,EAAnC,MALC,KAYT,IAAMmqD,EAAax+C,IAEnB,U,8ECnCe,SAASy+C,EAAgBruB,EAAU/2C,GAChD,KAAM+2C,aAAoB/2C,GACxB,MAAM,IAAIf,UAAU,qCCFxB,SAASomE,EAAkBt2E,EAAQiH,GACjC,IAAK,IAAIjG,EAAI,EAAGA,EAAIiG,EAAM/H,OAAQ8B,IAAK,CACrC,IAAI4S,EAAa3M,EAAMjG,GACvB4S,EAAWgL,WAAahL,EAAWgL,aAAc,EACjDhL,EAAW2D,cAAe,EACtB,UAAW3D,IAAYA,EAAWiL,UAAW,GACjD/c,OAAO6E,eAAe3G,EAAQ4T,EAAWvF,IAAKuF,IAInC,SAAS2iE,EAAatlE,EAAaulE,EAAYC,GAG5D,OAFID,GAAYF,EAAkBrlE,EAAY1P,UAAWi1E,GACrDC,GAAaH,EAAkBrlE,EAAawlE,GACzCxlE,E,qoBCTH,cAAoE,IAA5BnQ,EAA4B,uDAApE,GACJ,IAAK+gC,EAAL,WACCA,EAAA,aAEG,SAAJ,GACE,OAAAlY,EAAA,MAAa,4JAMf,IAAMwX,EAAargC,EAAA,YAAnB,GACMwmB,EAAaxmB,EAAA,YAAnB,GAEA,IAAK,IAAL,OAA+B,CAC7B,IAAM23C,EAAYnxB,EAAlB,GAEA6P,EAAA,gBAGF,SAAUu/C,EAAT,GACC,KAAgB,CACd,IAAK,IAAL,OAA8B,CAC5B,IAAM7mE,EAAYsxB,EAAlB,GACItxB,IAAc6mE,EAAmB7mE,EAArC,0BACEsnB,EAAA,eAGJ,SAEF,UAVF,CApBwE,GAoCpEA,EAAJ,sBACAA,EAAA,uBAEAA,EAAA,MAAU,CACRle,aADQ,WAEN,IAAMxG,EAAUpS,KAAhB,SAEIoS,EAAJ,SACEA,EAAA,kBAA2BpS,KAA3B,aACAA,KAAA,SAAgB82B,EAAA,WAAe1kB,EAAA,QAA/B,YAEApS,KAAA,SAAiBoS,EAAA,QAAkBA,EAAA,OAAnB,UAAhBpS,MAGJ86C,YAXQ,WAaF96C,KAAKuY,SAAS+9D,SAAWt2E,KAAzB,KAAqCA,KAAKq6B,IAAI0R,aAAlD,0BAEE/rC,KAAA,sBAFsF,EAItFA,KAAA,iCAGJsjC,QApBQ,WAsBFtjC,KAAKuY,SAAS+9D,SAAWt2E,KAAK8iD,SAAlC,cAEE9iD,KAAA,sBAFsD,EAItDA,KAAA,mC,oBCrEO,SAASu2E,EAA8BnrE,EAAQorE,GAC5D,GAAc,MAAVprE,EAAgB,MAAO,GAC3B,IAEI4C,EAAKrN,EAFLhB,EAAS,GACT82E,EAAah1E,OAAOmb,KAAKxR,GAG7B,IAAKzK,EAAI,EAAGA,EAAI81E,EAAW53E,OAAQ8B,IACjCqN,EAAMyoE,EAAW91E,GACb61E,EAAShgE,QAAQxI,IAAQ,IAC7BrO,EAAOqO,GAAO5C,EAAO4C,IAGvB,OAAOrO,ECXM,SAAS+2E,EAAyBtrE,EAAQorE,GACvD,GAAc,MAAVprE,EAAgB,MAAO,GAC3B,IACI4C,EAAKrN,EADLhB,EAASg3E,EAA6BvrE,EAAQorE,GAGlD,GAAI/0E,OAAOwlD,sBAAuB,CAChC,IAAI2vB,EAAmBn1E,OAAOwlD,sBAAsB77C,GAEpD,IAAKzK,EAAI,EAAGA,EAAIi2E,EAAiB/3E,OAAQ8B,IACvCqN,EAAM4oE,EAAiBj2E,GACnB61E,EAAShgE,QAAQxI,IAAQ,GACxBvM,OAAOP,UAAUolD,qBAAqBvnD,KAAKqM,EAAQ4C,KACxDrO,EAAOqO,GAAO5C,EAAO4C,IAIzB,OAAOrO,ECjBM,SAASk3E,EAAgBz0E,EAAGyJ,GAMzC,OALAgrE,EAAkBp1E,OAAOyuD,gBAAkB,SAAyB9tD,EAAGyJ,GAErE,OADAzJ,EAAEsiB,UAAY7Y,EACPzJ,GAGFy0E,EAAgBz0E,EAAGyJ,GCLb,SAASirE,EAAUC,EAAUC,GAC1C,GAA0B,oBAAfA,GAA4C,OAAfA,EACtC,MAAM,IAAInnE,UAAU,sDAGtBknE,EAAS71E,UAAYO,OAAO2Y,OAAO48D,GAAcA,EAAW91E,UAAW,CACrEsB,YAAa,CACXmG,MAAOouE,EACPv4D,UAAU,EACVtH,cAAc,KAGd8/D,GAAY9mB,EAAe6mB,EAAUC,G,oBCb5B,SAASC,EAAgB70E,GAItC,OAHA60E,EAAkBx1E,OAAOyuD,eAAiBzuD,OAAOg+C,eAAiB,SAAyBr9C,GACzF,OAAOA,EAAEsiB,WAAajjB,OAAOg+C,eAAer9C,IAEvC60E,EAAgB70E,GCJV,SAAS80E,IACtB,GAAuB,qBAAZz2D,UAA4BA,QAAQngB,UAAW,OAAO,EACjE,GAAImgB,QAAQngB,UAAUsT,KAAM,OAAO,EACnC,GAAqB,oBAAVujE,MAAsB,OAAO,EAExC,IAEE,OADAlqE,QAAQ/L,UAAU6hE,QAAQhkE,KAAK0hB,QAAQngB,UAAU2M,QAAS,IAAI,iBACvD,EACP,MAAOlB,GACP,OAAO,G,yBCTI,SAASqrE,EAAuB5zB,GAC7C,QAAa,IAATA,EACF,MAAM,IAAI6zB,eAAe,6DAG3B,OAAO7zB,ECHM,SAAS8zB,EAA2B9zB,EAAMzkD,GACvD,OAAIA,GAA2B,WAAlBurD,IAAQvrD,IAAsC,oBAATA,EAI3Cw4E,EAAsB/zB,GAHpBzkD,ECDI,SAASy4E,EAAaC,GACnC,IAAIC,EAA4BC,IAChC,OAAO,WACL,IACI1uE,EADA24B,EAAQ6d,EAAeg4B,GAG3B,GAAIC,EAA2B,CAC7B,IAAItnB,EAAY3Q,EAAez/C,MAAMwC,YACrCyG,EAASwX,QAAQngB,UAAUshC,EAAOxiC,UAAWgxD,QAE7CnnD,EAAS24B,EAAMziC,MAAMa,KAAMZ,WAG7B,OAAOw4E,EAA0B53E,KAAMiJ,I,cChB5B,GACb4uE,MADa,QAEbjlB,MAFa,QAGbklB,aAAc,CACZC,cADY,4BAEZC,YAAa,oBAEfC,UAAW,CACTC,iBADS,iBAETC,UAAW,CACTC,eADS,qBAETC,cAFS,oBAGTC,SAHS,cAITC,aAJS,8BAKTC,mBALS,+BAMTC,kBAAmB,+BAErBC,OAAQ,WAEVC,WAAY,CACVT,iBADU,kBAEVU,gBAFU,MAGVC,SAHU,YAIVC,SAJU,gBAKVC,UALU,aAMVC,SANU,YAOVC,SAAU,kBAEZC,WAAY,CACVC,cADU,eAEVC,mBAFU,aAGVC,kBAHU,YAIVC,mBAJU,iBAKVC,kBAAmB,iBAErBC,WAnCa,oBAoCbC,SAAU,CACR71B,KADQ,kBAER1yC,KAFQ,cAGRinE,UAAW,CACTuB,UAAW,8BAGfC,SAAU,CACRC,WAAY,YAEdC,UAAW,CACT7vD,QADS,YAET8vD,YAAa,4BAEfC,WAAY,CACVC,GADU,KAEVC,GAAI,MAENC,WAAY,CACV/B,UAAW,CACTnrB,QADS,wBAET97C,KAFS,YAGTk8C,SAHS,gBAIT+sB,KAJS,gBAKTC,YAAa,2BAGjBC,OAAQ,CACNlC,UAAW,CACT9rE,KAAM,uBCpDC,EAAwB,CACnCrE,WAAY,CAEVsyE,iBAFU,KAGVC,eAHU,GAIVC,WAAY,CACVC,GADU,IAEVC,GAFU,IAGVC,GAHU,KAIVC,GAAI,OAGRC,MAAO,CAELC,SAFK,MAGLz3E,OAAQ,IAEV03E,KAAM,CACJj4C,QADI,KAEJk4C,QAAS,CAAEC,MAEX3Q,OAAGxrE,GAELo8E,KAvBmC,EAwBnCvqB,MAAO,CACLH,MADK,EAELtpD,QAFK,QAGLi0E,SAHK,EAIL/oE,QAAS,CACPgpE,cADO,EAEPC,sBAFO,EAGPC,iBAHO,EAIPC,gBAJO,EAKPC,YAAY,GAEdC,OAAQ,CACNhrB,MAAO,CACLirB,QADK,UAELC,UAFK,UAGLC,OAHK,UAIL/5E,MAJK,UAKLgnB,KALK,UAMLgzD,QANK,UAOLC,QAAS,WAEXtrB,KAAM,CACJkrB,QADI,UAEJC,UAFI,UAGJC,OAHI,UAIJ/5E,MAJI,UAKJgnB,KALI,UAMJgzD,QANI,UAOJC,QAAS,c,YC3DX,EAAN,kCACE,KAAAC,UAAA,GADF,8BAGE,SAAI,UAHN,KCSM,EAAN,8BAGE,gBAEiB,+BAKf,IAAMC,EAAgB,eAAU,GALjB,GAOPC,EAPO,EAOPA,WAER,IACEC,OAAQC,OADV,MAAM,GAAN,EAEKD,EAFL,gBATe,OAcf,MAAIC,EAAA,QACF,OAAA7yD,EAAA,uFAGFrR,EAAA,OAAgB,eACd,eAAU+jE,EADa,GAAzB,GAlBe,EALnB,UAAM,GACG,EAAA92D,SAAA,U,gBCVH,G,UAAN,kE,0BAGE,EAAAk3D,IAAA,EAEA,EAAAz/B,IAAA,EAEA,EAAAlwC,KAAA,EAEA,EAAA4vE,YAAA,EAEA,EAAA3vE,MAAA,EAEA,EAAAw1C,OAAA,EAEA,EAAAo6B,OAAA,EAEA,EAAAz2B,YAA4C,CAC1Cu2B,IAD0C,GAE1Cz/B,IAF0C,GAG1ClwC,KAH0C,GAI1C4vE,YAJ0C,GAK1C3vE,MAL0C,GAM1Cw1C,OAN0C,GAO1Co6B,OAAQ,IAxBZ,oCA2BE,SAAQ,OAKNt8E,KAAA,iCAA+B,EAAO2M,GAEtC3M,KAAA,YAlCJ,wBAqCE,SAAU,KACR,MAAIA,KAAK6lD,YAAYpI,GAAU18B,YAExB/gB,KAAK6lD,YAAYpI,GAAxB,GACAz9C,KAAA,aAzCJ,oBA4CE,SAAM,GACJA,KAAA,GAAiByB,OAAA,OAAczB,KAAK6lD,YAAnB,YACP,qBAAuCkkB,EADhC,IAAjB,OA7CJ,GAAM,IACG,EAAA7kD,SAAA,c,cCAH,EAAN,8BAuDE,cAAkC,+BAnD3B,EAAAu1D,IAAA,EAEA,EAAAC,IAAA,EAEA,EAAAC,IAAA,EAEA,EAAAC,IAAA,EAEA,EAAA2B,IAAA,EAEA,EAAAC,QAAA,EAEA,EAAAC,QAAA,EAEA,EAAAC,WAAA,EAEA,EAAAC,SAAA,EAEA,EAAAC,QAAA,EAEA,EAAAC,WAAA,EAEA,EAAAC,SAAA,EAEA,EAAAC,QAAA,EAEA,EAAAC,WAAA,EAEA,EAAAC,SAAA,EAEA,EAAAC,QAAA,EAGA,EAAAz6E,KAAA,KAEA,EAAAgM,OAAA,EAEA,EAAAC,MAAA,EAIA,EAAAyuE,QAAA,EAQC,EAAAC,cAAA,EAKN,MAIIlB,EAAOmB,EAJX,UAAM,EAAN,EAAM,mBAAN,EAAM,eAGJ7C,EAHF,EAGEA,WAN8B,OAShC,qBACA,mBACA,eAXgC,EAvDpC,8BAqES,WACLx6E,KAAA,SAGA,qBAAWwB,QAEXA,OAAA,0BAEExB,KAAKs9E,SAASx8E,KAFhB,MAGE,CAAEmqB,SAAS,MA9EjB,oBAmFS,WAAmB,IAAXsyD,EAAW,wDAClB9uE,EAAS8uE,EAAM,EAAIv9E,KAAzB,kBACM0O,EAAQ6uE,EAAM,EAAIv9E,KAAxB,iBAEMy6E,EAAK/rE,EAAQ1O,KAAKw6E,WAAxB,GACME,EAAKhsE,EAAQ1O,KAAKw6E,WAAb,KAAX,EACMG,EAAKjsE,EAAS1O,KAAKw6E,WAAWG,GAAK36E,KAA9B,kBAAwD06E,GAAnE,GACME,EAAKlsE,EAAS1O,KAAKw6E,WAAWI,GAAK56E,KAA9B,kBAAwD26E,GAAA,GAAnE,GACM4B,EAAK7tE,GAAU1O,KAAKw6E,WAAWI,GAAK56E,KAA1C,eAuBA,OArBAA,KAAA,SACAA,KAAA,QAEAA,KAAA,KACAA,KAAA,KACAA,KAAA,KACAA,KAAA,KACAA,KAAA,KAEAA,KAAA,SACAA,KAAA,SACAA,KAAA,WAAkBy6E,GAAD,MAAgBE,GAAA,GAAjC,GACA36E,KAAA,SAAgBy6E,IAAOC,GAAA,MAAvB,GACA16E,KAAA,SACAA,KAAA,WAAkBy6E,GAAA,GAAD,MAAsBG,GAAvC,GACA56E,KAAA,UAAiBy6E,GAAF,KAAgBE,GAAA,GAA/B,GACA36E,KAAA,SACAA,KAAA,WAAkBy6E,GAAA,MAAD,KAAjB,EACAz6E,KAAA,UAAiBy6E,GAAA,GAAF,KAAsBG,GAArC,GACA56E,KAAA,UAEA,GACE,OACEA,KAAA,UACA,MACF,OACEA,KAAA,UACA,MACF,OACEA,KAAA,UACA,MACF,OACEA,KAAA,UACA,MACF,QACEA,KAAA,UACA,MAGJ,qBAAWA,KAAP,iBAAJ,CAMA,IAAMyG,EAAc,CAClBg0E,GADkB,EAElBC,GAFkB,EAGlBC,GAHkB,EAIlBC,GAJkB,EAKlB2B,GAAI,GAGAz5C,EAAUr8B,EAAYzG,KAA5B,MACM8S,EAAMrM,EAAYzG,KAAxB,kBAEAA,KAAA,OAAc8iC,GAAd,OAhBE9iC,KAAA,OAAc0O,EAAQ80B,SAASxjC,KAAD,iBAA9B,MArIN,sBAwJU,WACNq4B,aAAar4B,KADC,eAOdA,KAAA,cAAqBwB,OAAA,WAAkBxB,KAAKyhB,OAAO3gB,KAA9B,MAArB,OA/JJ,4BAoKU,WAEN,2BAAWqpB,SAFS,EAGbhlB,KAAA,IACLglB,SAAA,gBADK,YAEL3oB,OAAA,YAFF,KAvKJ,6BA6KU,WAEN,2BAAW2oB,SAFU,EAGdhlB,KAAA,IACLglB,SAAA,gBADK,aAEL3oB,OAAA,aAFF,OAhLJ,GAAM,GACU,EAAA0jB,SAAA,a,gBCLHs4D,G,UAAU,SAAAlT,GAAD,OAAf,IAEMmT,EAAc,SAAAnT,GAAD,gBAAeA,EAAlC,IAEMoT,EAAe,SAAApT,GAAD,OAAeA,GAAK,EAAxC,IAEMqT,EAAiB,SAAArT,GAAD,OAAgBA,EAAA,GAAU,EAAI,KAAJ,IAAIA,EAAd,IAA6B,EAAI,EAAL,GAAlE,EAA8D,GAExDsT,EAAe,SAAAtT,GAAD,gBAAeA,EAAnC,IAEMuT,EAAgB,SAAAvT,GAAD,OAAe,gBAApC,GAEMwT,EAAkB,SAAAxT,GAAD,OAAeA,EAAA,GAAU,EAAI,KAAJ,IAAIA,EAAd,IAAwBA,EAAD,IAAW,EAAIA,EAAf,IAAyB,EAAIA,EAA7B,GAA7D,GAEMyT,EAAe,SAAAzT,GAAD,gBAAeA,EAAnC,IAEM0T,EAAgB,SAAA1T,GAAD,OAAe,EAAI,KAAJ,MAAMA,EAA1C,IAEM2T,EAAkB,SAAA3T,GAAD,OAAgBA,EAAA,GAAU,EAAIA,EAAIA,EAAIA,EAAtBA,EAA8B,EAAI,UAAzE,GAEM4T,EAAe,SAAA5T,GAAD,gBAAeA,EAAnC,IAEM6T,EAAgB,SAAA7T,GAAD,OAAe,EAAI,KAAJ,MAAMA,EAA1C,IAEM8T,EAAkB,SAAA9T,GAAD,OAAeA,EAAA,GAAU,GAAK,KAAL,IAAKA,EAAf,GAAwB,EAAI,GAAK,KAAL,MAAOA,EAAzE,ICxBD,cACJ,qBAAW3qE,EACT,SAGF,IAAIm7B,EAAKz7B,EAAT,GACA,MACE,KAAwB,kBAAXM,EACT,IAAIk/C,MAAM,mBAAV,OADE,EACF,iBACA,IAAIhvC,UAAU,uEAAd,OAAqF,EAFzF,GAEI,cAGN,IAAIwuE,EAAJ,EACA,QACEA,GAAevjD,EAAf,UACAA,EAAKA,EAAL,aAGF,SAGI,cACJ,IAAMA,EAAKz7B,EAAX,GAEA,KAAQ,OAAOy7B,EAEf,KAA2B,kBAAdk+B,EACT,IAAIna,MAAM,sBAAV,OADE,EACF,iBACA,IAAIhvC,UAAU,mEAAd,OAAiF,EAFrF,GAEI,cAGN,SAAS,EAAT,GACE,OAAO,MAAAirB,IAAkBA,EAAA,YAAzB,KAGF,SAASz7B,EAAT,GACE,wBAAWy7B,EACF3Q,SAAA,cAAP,GACS2Q,GAAMA,EAAV,OACGA,EAAR,IACSA,aAAJ,YACL,EAEA,KC/BU,cAEwB,IAApCwjD,EAAoC,uDAFxB,GAINC,EAAQ,gBACZvlB,UAAY7uC,SAAA,kBAAoDA,SAApD,MAAqEA,SADrD,gBAE5BksB,SAF4B,IAG5B2V,OAH4B,EAI5BwyB,OAJ4B,iBAK5BC,WAL4B,GAMzBH,GAECtlB,EAAY0lB,EAAaH,EAA/B,WAGA,GAAIA,EAAA,WAAsBI,EAAA,UAA1B,YAAsD,CACpD,IAAMC,EAAW5lB,EAAA,mBAAjB,uBACM6lB,EAAY7lB,EAAA,mBAAlB,gCACA,EAAqB2lB,EAAA,UAArB,YAAM,EAAN,EAAM,IAAOhiC,EAAb,EAAaA,IAEb4hC,EAAA,UAEKK,IAAL,IAA4BL,EAAA,WAG9B,IAEA,EAFMO,EAAYvhE,YAAlB,MAIEwhE,EADF,kBAAW/lD,EACQgmD,EAAA,GAAqBT,EAAtC,OAEiBS,EAAA,GAAqBA,EAArB,GAA4CT,EAA7D,OAGF,IAAMU,EAAgBjmB,EAAtB,UACA,GAAI+lB,IAAJ,EAAsC,OAAOx6E,QAAA,QAAP,GAEtC,IAAM26E,EAAO,oBAAOX,EAAP,OACTA,EADS,OAET,EAAeA,EAFnB,QAIA,MAAW,MAAM,IAAI1uE,UAAU,oBAAd,OAAkC0uE,EAvCf,OAuCnB,iBAIjB,OAAO,IAAIh6E,SAAQ,SAAAC,GAAO,OAAIsvC,uBAAsB,SAASvhC,EAAT,GAClD,IAAM4sE,EAAcC,EAApB,EACMC,EAAWl6E,KAAA,IAASo5E,EAAA,SAAoBp5E,KAAA,IAASg6E,EAAcZ,EAAvB,SAApB,GAA1B,GAEAvlB,EAAA,UAAsB7zD,KAAA,MAAW85E,GAAiBF,EAAD,GAAmCG,EAApF,IAEA,IAAMI,EAAetmB,IAAc7uC,SAAd,KAA8BA,SAAA,gBAA9B,aAAsE6uC,EAA3F,aACA,GAAI,IAAAqmB,GAAkBC,EAAetmB,EAAf,YAAuCA,EAA7D,aACE,OAAOx0D,EAAP,GAGFsvC,sBAAA,SAIJ6qC,EAAA,aACAA,EAAA,KAAY,aAEL,IAAD,EAAN,8BAGE,mBAGE,OAHF,UACE,eAEA,OANJ,UAAM,GACU,EAAAz5D,SAAA,O,wBC7EV21D,EAAsB,CAC1B0E,SAD0B,0DAE1B7hB,OAF0B,2MAG1B9K,MAH0B,gHAI1B9uB,OAJ0B,2MAK1BjjB,MAL0B,gHAM1Bg7D,QAN0B,4JAO1BhzD,KAP0B,2HAQ1BizD,QAR0B,kDAS1Bj6E,MAT0B,oDAU1B+hD,KAV0B,gEAW1B1yC,KAX0B,8DAY1BsuE,WAZ0B,iJAa1BC,YAb0B,iHAc1BC,sBAd0B,gHAe1BhG,UAf0B,+FAgB1B/8C,KAhB0B,yEAiB1BgjD,OAjB0B,6DAkB1BC,KAlB0B,iDAmB1BC,SAnB0B,uBAoB1BC,SApB0B,uBAqB1BC,QArB0B,sRAsB1BC,SAtB0B,2LAuB1BC,KAvB0B,sJAwB1BC,YAxB0B,kNAyB1BC,WAzB0B,uGA0B1BC,WA1B0B,iKA2B1BxoD,QA3B0B,uPA4B1B00B,MA5B0B,8EA6B1Bz/B,KA7B0B,2EA8B1BwzD,OA9B0B,oHA+B1BzR,KA/B0B,8WAgC1B0R,KAhC0B,4CAiC1BC,MAAO,sBAGT,ICpCM,EAAsB,CAC1BhB,SAD0B,QAE1B7hB,OAF0B,SAG1B9K,MAH0B,QAI1B9uB,OAJ0B,SAK1BjjB,MAL0B,QAM1Bg7D,QAN0B,eAO1BhzD,KAP0B,OAQ1BizD,QAR0B,gBAS1Bj6E,MAT0B,UAU1B+hD,KAV0B,eAW1B1yC,KAX0B,gBAY1BsuE,WAZ0B,YAa1BC,YAb0B,0BAc1BC,sBAd0B,0BAe1BhG,UAf0B,sBAgB1B/8C,KAhB0B,eAiB1BgjD,OAjB0B,sBAkB1BC,KAlB0B,OAmB1BC,SAnB0B,kBAoB1BC,SApB0B,kBAqB1BC,QArB0B,uBAsB1BC,SAtB0B,yBAuB1BC,KAvB0B,OAwB1BC,YAxB0B,cAyB1BC,WAzB0B,OA0B1BC,WA1B0B,YA2B1BxoD,QA3B0B,SA4B1B00B,MA5B0B,aA6B1Bz/B,KA7B0B,YA8B1BwzD,OA9B0B,cA+B1BzR,KA/B0B,cAgC1B0R,KAhC0B,MAiC1BC,MAAO,UAGT,ICpCM,EAAsB,CAC1BhB,SAD0B,YAE1B7hB,OAF0B,mBAG1B9K,MAH0B,YAI1B9uB,OAJ0B,mBAK1BjjB,MAL0B,YAM1Bg7D,QAN0B,mBAO1BhzD,KAP0B,kBAQ1BizD,QAR0B,kBAS1Bj6E,MAT0B,YAU1B+hD,KAV0B,mBAW1B1yC,KAX0B,oBAY1BsuE,WAZ0B,sBAa1BC,YAb0B,6BAc1BC,sBAd0B,gBAe1BhG,UAf0B,aAgB1B/8C,KAhB0B,eAiB1BgjD,OAjB0B,mBAkB1BC,KAlB0B,WAmB1BC,SAnB0B,gBAoB1BC,SApB0B,gBAqB1BC,QArB0B,sBAsB1BC,SAtB0B,qBAuB1BC,KAvB0B,aAwB1BC,YAxB0B,mBAyB1BC,WAzB0B,WA0B1BC,WA1B0B,qBA2B1BxoD,QA3B0B,aA4B1B00B,MA5B0B,iBA6B1Bz/B,KA7B0B,gBA8B1BwzD,OA9B0B,6BA+B1BzR,KA/B0B,gBAgC1B0R,KAhC0B,WAiC1BC,MAAO,aAGT,KCpCM,GAAsB,CAC1BhB,SAD0B,eAE1B7hB,OAF0B,sBAG1B9K,MAH0B,eAI1B9uB,OAJ0B,sBAK1BjjB,MAL0B,sBAM1Bg7D,QAN0B,sBAO1BhzD,KAP0B,qBAQ1BizD,QAR0B,qBAS1Bj6E,MAT0B,8BAU1B+hD,KAV0B,sBAW1B1yC,KAX0B,uBAY1BsuE,WAZ0B,sBAa1BC,YAb0B,gBAc1BC,sBAd0B,sBAe1BhG,UAf0B,gBAgB1B/8C,KAhB0B,iBAiB1BgjD,OAjB0B,sBAkB1BC,KAlB0B,cAmB1BC,SAnB0B,oBAoB1BC,SApB0B,oBAqB1BC,QArB0B,oBAsB1BC,SAtB0B,gBAuB1BC,KAvB0B,cAwB1BC,YAxB0B,cAyB1BC,WAzB0B,cA0B1BC,WA1B0B,mBA2B1BxoD,QA3B0B,cA4B1B00B,MA5B0B,uBA6B1Bz/B,KA7B0B,sBA8B1BwzD,OA9B0B,sBA+B1BzR,KA/B0B,mBAgC1B0R,KAhC0B,cAiC1BC,MAAO,gBAGT,MCpCM,GAAsB,CAC1BhB,SAD0B,cAE1B7hB,OAF0B,qBAG1B9K,MAH0B,cAI1B9uB,OAJ0B,qBAK1BjjB,MAL0B,qBAM1Bg7D,QAN0B,qBAO1BhzD,KAP0B,oBAQ1BizD,QAR0B,oBAS1Bj6E,MAT0B,6BAU1B+hD,KAV0B,qBAW1B1yC,KAX0B,sBAY1BsuE,WAZ0B,qBAa1BC,YAb0B,iBAc1BC,sBAd0B,qBAe1BhG,UAf0B,eAgB1B/8C,KAhB0B,gBAiB1BgjD,OAjB0B,qBAkB1BC,KAlB0B,aAmB1BC,SAnB0B,mBAoB1BC,SApB0B,mBAqB1BC,QArB0B,qBAsB1BC,SAtB0B,iBAuB1BC,KAvB0B,eAwB1BC,YAxB0B,eAyB1BC,WAzB0B,aA0B1BC,WA1B0B,oBA2B1BxoD,QA3B0B,gBA4B1B00B,MA5B0B,sBA6B1Bz/B,KA7B0B,qBA8B1BwzD,OA9B0B,0BA+B1BzR,KA/B0B,kBAgC1B0R,KAhC0B,aAiC1BC,MAAO,eAGT,M,oBClCM,iBAIJ,IAAMt3E,EAAN,GAEA,IAAK,IAAL,OACEA,EAAA,GAAc,CACZuG,YACA5I,MAAO,CACLyF,KAAOm0E,EAAA,mBAKb,SAGa,OAAAC,GAA+B,oBAA9C,ICfe,GAAAh/E,OAAA,OAAc,CAC3Bi/E,OAAA,EACA/F,KACAgG,OACAC,MACAC,OACAC,MAAA,KCAI,GAAN,8BASE,cAAkC,gBAChC,eAEA,MAII5E,EAAO6E,EAJX,UAAM,EAAN,EAAM,WAAN,EAAM,OAGJvxE,EAHF,EAGEA,UAN8B,OAShC,cACA,aACA,SAAc,eACZwxE,GADqB,GAAvB,GAXgC,EATpC,UAAM,GACG,GAAA97D,SAAA,Q,4CCAH+7D,GAAN,YACMxyD,GAAWjO,OAAjB,iBAEA,SAAS0gE,GAAT,KAI8B,IAD5BC,EAC4B,wDAJ9B,EAI8B,uCAEtBC,EAAWpzE,EAAA,WAAjB,IACIqzE,EAAc,eAAqBC,EAAQF,EAA/C,IAYA,OAVIC,IAAJ,KACE,GACE,OAAA/3D,EAAA,MAAa,oBAAD,OAAZ,EAAY,4BACZ+3D,EAAA,IAEA,OAAA/3D,EAAA,MAAY,oBAAD,OAAX,EAAW,yCACX+3D,EAAcH,GAAeK,EAAevzE,GAAK,EAAjD,KAIJ,EAGK,IAAD,GAAN,8BAWE,cAAkC,gBAChC,eAPK,EAAAuzE,cAAA,KASL,MAIIrF,EAAOsF,EAJX,UAAM,EAAN,EAAM,UAAN,EAAM,QAGJlX,EAHF,EAGEA,EAN8B,OAShC,YACA,YACA,aAAkBA,GAAK,EAAvB,kBAXgC,EAXpC,uCAyBS,SAAa,GAClB,IAAM+W,EAAcrhF,KAAKg7E,QAAQh7E,KAAjC,SACMuhF,EAAgBvhF,KAAKg7E,QAAQh7E,KAAnC,eAEA,OAAOkhF,GAAeG,EAAarzE,GAAK,EAAxC,KA7BJ,eAgCS,SAAC,GAA+B,2BAA/B,EAA+B,iCAA/B,EAA+B,kBACrC,OAAKA,EAAA,WAAL,IAEOhO,KAAKyhF,WAAL,MAAAzhF,KAAA,WAAP,IAFyCA,KAAKoF,QAAQ4I,EAApB,KAjCtC,+BAsCU,SAAiB,GAA+B,2BAA/B,EAA+B,iCAA/B,EAA+B,kBACtD,OAAOhO,KAAKoF,QAAQpF,KAAK0hF,cAAlB,GAAP,KAvCJ,qBA0CU,SAAO,KACb,OAAOl8E,EAAA,sBAA0B,cAE/B,OAAO/G,OAAOotB,GAAd,WA7CN,GAAM,GACG,GAAA3G,SAAA,O,8ECtCHy8D,I,UAAN,oBAEMC,GAA0B,SAAAtX,GAAD,OAC7BA,EAAI,KAAH,IAAGqX,GAAJ,GACIx8E,KAAA,KADJmlE,GAEKA,GAAK,EAAI,KAAJ,IAAIqX,GAAV,IAAyB,EAH/B,IAMME,GAA0B,SAAAvX,GAAD,OAC7BA,EAAA,YACIA,EADJ,GAEK,EAAI,KAAJ,IAAIqX,GAAL,IAAoBrX,EAAI,EAH9B,KAMM,eACJ,IAAMtuB,EAAN,GACM8lC,EAAe9lC,EAAUihB,EAA/B,IAEA,MAAO,CACL,IAAM6kB,EADD,GAEL,KAAO9lC,EAAUihB,EAAA,GAAV,QAFF,GAGL,KAAO6kB,EAAe9lC,EAAUihB,EAAA,GAHlC,WAOI,eACJ,IAAMjhB,EAAN,GACM+lC,GAAMC,EAAA,GAAD,IAAX,IACA,MAAO,QACLhmC,EAAU+lC,EAAKC,EAAA,GAAf,KACAhmC,EAFK,GAAP,QAGEA,EAAU+lC,EAAKC,EAAA,GAAf,MCxBE,eASJ,IANiB,IADjBC,EACiB,wDAAjBzG,IAAiB,yDAEX,EAAN,EAAM,OAAa0G,EAAnB,gBACMC,EAAS1gF,OAAA,KAAf,GACM2gF,EAAN,GAESzhF,EAAT,EAAgBA,EAAIwhF,EAApB,WAAwC,CACtC,IAAM1/E,EAAO0/E,EAAb,GACMx5E,EAAQgoD,EAAd,GAEA,MAAIhoD,IAEJ,EAEWs5E,GAEL,SAAAx/E,GAAmBA,EAAA,WAAnB,YAAiDA,EAAA,WAArD,aACE2/E,EAAA,GAAoB,gBAApB,IAEG,WAAI,mBACTA,EAAA,GAAoB9sE,GAAM3M,GAAO,EAAjC,GAEAy5E,EAAA,GAAoBC,GAAc5/E,EAAM,gBAAxC,IATA2/E,EAAA,GAAoB,CAAEhrD,KAAM,gBAAS,gBAAD,MAiBxC,OAJA,IACEgrD,EAAA,OAAqBzxE,GAAUyxE,EAAV,MAA8BA,EAAA,QAAnD,MAGF,EAMF,IAAME,GAAe,SAAC7/E,EAAD,GACnB,kCACgBA,EADhB,mCAEoBkG,EAFpB,yCAGgBA,EAHhB,4CAKgBlG,EALhB,8BAMSkG,EANT,wCAOeA,EAPf,oBAcI,GAAkB,SAAClG,EAAD,KACtB,MAAkBy/E,EAAA,aAAlB,0BAAM,EAAN,KAAM,EAAN,KACA,kCACgBz/E,EADhB,YACwBwE,EADxB,YACgC1E,EADhC,mCAEoBoG,EAFpB,yCAGgBA,EAHhB,4CAKgBlG,EALhB,wBAKoCwE,EALpC,YAK4C1E,EAL5C,wBAMSoG,EANT,wCAOeA,EAPf,oBAWI45E,GAAuB,SAAC9/E,GAAD,IAAey/E,EAAf,kFAAmDz/E,EAAnD,YAA7B,IAEM+/E,GAAmB,SAAC//E,GAAD,IAAey/E,EAAf,kFAAmDK,GAAqB9/E,EAAjG,GAAyB,MAEnB,eAA8D,IAAdggF,EAAc,wDAC5D,EAAN,EAAM,OAAaP,EAAnB,gBACMC,EAAS1gF,OAAA,KAAf,GAEA,IAAK0gF,EAAL,OAAoB,MAAO,GAE3B,IAAIO,EAAJ,GACIhwC,EAAJ,GAEMiwC,EAASF,EAASD,GAAH,UAArB,EACA9vC,GAAO,6BAAJ,OAAH,EAAG,OACH+vC,IAAWC,GAAgB,KAAJ,OAASH,GAAqB,UAA9B,aAAvB,EAAuB,QAEvB,IAAK,IAAI5hF,EAAT,EAAgBA,EAAIwhF,EAApB,WAAwC,CACtC,IAAM1/E,EAAO0/E,EAAb,GACMx5E,EAAQgoD,EAAd,GAEAje,GAAO4vC,GAAa7/E,EAAMggF,EAASD,GAAH,GAA4B75E,EAA5D,MACA85E,IAAWC,GAAgB,KAAJ,OAASH,GAAqB9/E,GAA9B,aAAwCkG,EAA/D,KAAuB,QAGvB,IADA,IAAMi6E,EAAW,eAAjB,GACS,EAAT,EAAgB,EAAIA,EAApB,WAA0C,CACxC,IAAM,EAAUA,EAAhB,GACMC,EAAel6E,EAArB,GACA,SAAI,IAEJ+pC,GAAO,GAAgBjwC,EAAM,EAASggF,EAASD,GAAiB//E,EAApB,GAA5C,GACAggF,IAAWC,GAAgB,KAAJ,OAASH,GAAqB9/E,EAAM,GAApC,aAAvB,EAAuB,UAQ3B,OAJA,IACEigF,EAAe,YAAH,OAAZA,EAAY,UAGPA,EAAP,EAGI,iBAKJ,IAJA,IAAMr/E,EAAiC,CACrC+zB,KAAM,gBAASzuB,IAGRhI,EAAT,EAAgBA,EAAhB,MACE0C,EAAO,UAAD,OAAN,IAAwB,gBAASy/E,GAAQn6E,EAAzC,IAGF,IAAK,IAAI,EAAT,EAAgB,GAAhB,MACEtF,EAAO,SAAD,OAAN,IAAuB,gBAAS0/E,GAAOp6E,EAAvC,IAGF,SAGI,iBACJ,IAAMq5E,EAAM,GAAY,QAAxB,IAEA,OADAA,EAAA,GAASA,EAAA,GAAT,GAAkBgB,EACX,QAAa,GAApB,IAGI,iBACJ,IAAMhB,EAAM,GAAY,QAAxB,IAEA,OADAA,EAAA,GAASA,EAAA,GAAT,GAAkBgB,EACX,QAAa,GAApB,IC7HK,IAAD,GAAN,8BAmBE,cAAkC,gBAChC,eAjBK,EAAAx2E,UAAA,EAUC,EAAAkkD,OAAA,KAEA,EAAAuyB,QAAA,KAEA,EAAAC,QAAA,KAKN,MAKIhH,EAAOiH,EALX,UAAM,EAAN,EAAM,OAAN,EAAM,UAAN,EAAM,QAIJ1H,EAJF,EAIEA,OAOF,OAJA,OAAYxuE,QAAZ,GACA,WAAgB,SAAhB,EACA,YAEA,GACE,cAEA,OAGF,SAAc,CACZujD,KAAM,cAAiBirB,EAAjB,MADM,GAEZhrB,MAAO,cAAiBgrB,EAAjB,WAtBuB,GAnBpC,2BA+CE,YACMz7E,KAAJ,QACMA,KAAJ,aACEA,KAAA,iBAIJA,KAAA,8BAAqCA,KAAKojF,QAAL,UAArC,KAtDJ,gBAkEE,WACE,OAAOn2E,QAAQjN,KAAf,SAnEJ,IAyDE,YACE,IAAMqjF,EAAUrjF,KAAhB,OAEAA,KAAA,OAHoB,EAMpB,MAAAqjF,GAAmBrjF,KAAnB,eA/DJ,wBAwES,WACL,GAAIA,KAAJ,SAAmB,OAAOA,KAAP,WAEnBA,KAAA,IAAWA,KAAX,kBA3EJ,sBA8ES,WACLA,KAAA,SA/EJ,kBAqFS,SAAI,KACLA,KAAJ,WAGKmlE,EAAL,MACEnlE,KAAA,eACSgY,GACThY,KAAA,WAGFA,KAAA,gBA/FJ,sBAmGS,SAAQ,KACbA,KAAA,UAAqByB,OAAA,OAAczB,KAAKy7E,OAAnB,GAArB,GACAz7E,KAAA,eArGJ,yBAyGS,WACLA,KAAA,aAAoByB,OAAA,UAAkBzB,KAAKuD,SAA3C,OACAvD,KAAA,YAAmByB,OAAA,UAAkBzB,KAAKuD,SAA1C,MACAvD,KAAA,eA5GJ,uCAgHU,WAIN,OAHAA,KAAA,QAAemqB,SAAA,eAAf,8BAGInqB,KAAJ,UAEAA,KAN+B,kBAQxBiN,QAAQjN,KAAf,YAxHJ,yBA2HU,WAEO,IADb2wD,EACa,uDAFI,KAEJ,uCAEP2yB,EAAetjF,KAAKy7E,OAAOjrB,EAAO,OAAxC,SAEA,OAAO/uD,OAAA,YAAP,KAjIJ,6BAyIU,WAEN,qBAAW0oB,WAGXnqB,KAAA,QAAemqB,SAAA,cAAf,SACAnqB,KAAA,wBACAA,KAAA,sCAEIA,KAAKoS,QAAT,UACEpS,KAAA,6BAAmCA,KAAKoS,QAAxC,UAGF+X,SAAA,iBAA0BnqB,KAA1B,YAtJJ,yBAyJU,SAAW,GAAW,WAE5B,GADAA,KAAA,QAAemlE,EAAf,QACInlE,KAAJ,YAEEmlE,EAAA,WAAe,WACb,0BAHJ,CAQA,IAAMoe,EAAc,oBAAOvjF,KAAKkjF,QAAZ,WAAgDljF,KAAKkjF,QAAQM,aAA7D,QAApB,WACMC,EAAWte,EAAA,aAAjB,GAEAA,EAAA,YAA6B,WAC3Bse,EAAA,MAAiBA,EAAA,OAAjB,GAEA,IAAMC,EAAoBD,EAAA,YAAqB,SAAAnuC,GAAD,MAA9C,6BAA0DA,EAAA,MAa1D,OAXA,EAQEouC,EAAA,QAA4B,EAA5B,gBAPAD,EAAA,WAAoB,CAClB9yC,QAAS,EADS,gBAElB1pC,KAFkB,WAGlBga,GAHkB,2BAIlB0iE,OAAQ,WAAD,IAAqBvI,WAMhC,MAtLN,4BA0LU,WACN,MAAgBp7E,KAAKkjF,QAAQU,OAA7B,WAAQhjE,EAAR,EAAQA,IAERA,EAAI,CACFpS,MAAO,CAAC,CACNmiC,QAAS3wC,KADH,gBAENiH,KAFM,WAGNga,GAHM,2BAIN0iE,MAAO3jF,KAAKoS,QAAQgpE,eAlM5B,qBAuMU,SAAO,GAEb,IAAMuI,EAAQ3jF,KAAKoS,QAAQgpE,SAAW,WAAxB,OAAmCp7E,KAAKoS,QAAxC,cAAd,GACA4F,EAAA,KAAkBA,EAAA,MAAlB,GACAA,EAAA,oEAA0E2rE,EAA1E,YAAmF3jF,KAAnF,8BA3MJ,uBA8MU,SAAS,GAAW,WAE1B,qBAAWmqB,WAIPnqB,KAAJ,UACEA,KAAA,UACAA,KAAA,cAKFmlE,EAAA,sBAA2B,WACzB,IAAM0e,EAAM,kBAAe,CAAEpI,OAAQ,EAAKA,SAC1C,UAAetW,EAAA,QAAY,kBAAM0e,EAAlB,UAA8B,kBAAM,EAApC,eAAuD,CAAEvmD,MAAM,OAEhFt9B,KAAA,gBA/NJ,wBAkOE,WACE,IAAML,EAASK,KAAKwwD,KAAO,OAA3B,QAEA,OAAOxwD,KAAKy7E,OAAZ,KArOJ,2BAwOE,WACE,IAGA,EAHM9qB,EAAQ3wD,KAAd,YAEMoS,EAAUpS,KAAKoS,SAArB,GAGA,aAAIA,EAAA,aACFsgC,EAAMtgC,EAAA,eAAN,GAEA,MAAIsgC,KAGNA,EAAM,KAA4BtgC,EAAlC,kBAEA,MAAIA,EAAA,cACFsgC,EAAMtgC,EAAA,YAANsgC,IAGF,MAAItgC,EAAA,YACFA,EAAA,qBAVwBsgC,IAjP9B,uBAiQE,WACE,OAAO,GACL1yC,KAAK8jF,cADA,UAGL,eAAe9jF,KAAD,QAAe,CAAf,eAHhB,MAlQJ,uBA2QE,WACE,0BAAcA,KAAKkjF,QAAZ,WA5QX,GAAM,GACG,GAAAh+D,SAAA,Q,ICHK,G,WAqBZ,aAA+C,IAAlC+2D,EAAkC,uDAA/C,GAA+C,UAVxC,KAAAF,UAAgD,CACrDgI,aAAa,GAGR,KAAAC,UAAA,GAEA,KAAA9H,OAAA,GAEA,KAAAD,WAAA,GAGLj8E,KAAA,aAEAA,KAAA,IAAS,GACTA,KAAA,IAAS,GACTA,KAAA,IAAS,GACTA,KAAA,IAAS,GACTA,KAAA,IAAS,IACTA,KAAA,IAAS,IACTA,KAAA,IAAS,I,8BAMX,SAAI,KAAgC,WAClCA,KAAA,mBAAuB,SAAAklB,GACrB,IAAM++D,EAAU,YAAhB,GAEAA,EAAA,UAAoB,EAApB,UAEAA,EAAA,aAMFjkF,KAAA,cAAqBiN,QAAQjN,KAAKk8E,OAAlC,O,iBAIF,SAAG,GACD,IAAMh3D,EAAWg/D,EAAjB,SAEIlkF,KAAKgkF,UAAU1tE,SAAnB,KAGAtW,KAAA,aAA2B,IAAIkkF,EAAQlkF,KAAZ,OAA3BA,MACAA,KAAA,uB,KA1DK,GAAAwhC,UAEA,GAAAwiD,WAAA,EAEA,GAAAhgD,QAAA,QAEA,GAAAhgC,OAAS,CACdoZ,QAAQ,I,qBCxBZ,IAAIypD,EAAwB,EAAQ,QAChCsd,EAAa,EAAQ,QACrB/lF,EAAkB,EAAQ,QAE1BC,EAAgBD,EAAgB,eAEhCgmF,EAAuE,aAAnDD,EAAW,WAAc,OAAO/kF,UAArB,IAG/BilF,EAAS,SAAUziF,EAAIoM,GACzB,IACE,OAAOpM,EAAGoM,GACV,MAAOnM,MAIXtD,EAAOC,QAAUqoE,EAAwBsd,EAAa,SAAUviF,GAC9D,IAAI7B,EAAGqI,EAAKa,EACZ,YAAcnK,IAAP8C,EAAmB,YAAqB,OAAPA,EAAc,OAEM,iBAAhDwG,EAAMi8E,EAAOtkF,EAAI0B,OAAOG,GAAKvD,IAA8B+J,EAEnEg8E,EAAoBD,EAAWpkF,GAEH,WAA3BkJ,EAASk7E,EAAWpkF,KAAsC,mBAAZA,EAAEukF,OAAuB,YAAcr7E,I,kCCtB5F,IAAIzF,EAAQ,EAAQ,QAEpB,SAASC,IACPzD,KAAK67B,SAAW,GAWlBp4B,EAAmBvC,UAAUkgC,IAAM,SAAax8B,EAAWC,GAKzD,OAJA7E,KAAK67B,SAAS/2B,KAAK,CACjBF,UAAWA,EACXC,SAAUA,IAEL7E,KAAK67B,SAASh9B,OAAS,GAQhC4E,EAAmBvC,UAAUqjF,MAAQ,SAAetjE,GAC9CjhB,KAAK67B,SAAS5a,KAChBjhB,KAAK67B,SAAS5a,GAAM,OAYxBxd,EAAmBvC,UAAUuD,QAAU,SAAiB9F,GACtD6E,EAAMiB,QAAQzE,KAAK67B,UAAU,SAAwBjzB,GACzC,OAANA,GACFjK,EAAGiK,OAKTrK,EAAOC,QAAUiF,G,kCCnDjB,0BAUe,qBAAmB,CAChChB,KADgC,SAGhCmE,MAAO,CACLwB,IAAK,CACHnB,KADG,OAEHC,QAAS,SAIb4F,SAAU,CACRqJ,OADQ,WAEN,MAEInW,KAAK8iD,SAFT,YAAM,EAAN,EAAM,MAAN,EAAM,MAAN,EAAM,QAAN,EAAM,SAAN,EAAM,cAAN,EAAM,OAC0Cr2C,EADhD,EACgDA,KAGhD,MAAO,CACL+3E,WAAY,GAAF,OAAK7nC,EADV,EACK,MACV8nC,aAAc,GAAF,OAFP,EAEO,MACZ9f,cAAe,GAAF,OAAK2X,EAAA,EAHb,EAGQ,MACboI,YAAa,GAAF,OAAKj4E,EAAL,SAKjBlE,OAzBgC,SAyB1B,GACJ,IAAMtD,EAAO,CACX4D,YADW,SAEX2F,MAAOxO,KAFI,OAGXi3B,IAAK,QAGP,OAAOruB,EAAE5I,KAAD,MAAiB,CACvB4I,EAAE,MAEA,CAAEC,YAAa,gBACf7I,KAAKuN,OAJT,e,mBCvCJhP,EAAOC,QAAU2G,KAAKw8C,MAAQ,SAAcI,GAE1C,OAAmB,IAAXA,GAAKA,IAAWA,GAAKA,EAAIA,EAAIA,EAAI,GAAK,EAAI,I,qBCLpD,IAAIgM,EAAS,EAAQ,QACjBhtC,EAAM,EAAQ,QAEdnE,EAAOmxC,EAAO,QAElBxvD,EAAOC,QAAU,SAAUwP,GACzB,OAAO4O,EAAK5O,KAAS4O,EAAK5O,GAAO+S,EAAI/S,M,kCCLvC,IAAI3O,EAAI,EAAQ,QACZc,EAAW,EAAQ,QACnB2Z,EAAU,EAAQ,QAClB8tC,EAAkB,EAAQ,QAC1BpoD,EAAW,EAAQ,QACnB2B,EAAkB,EAAQ,QAC1BknD,EAAiB,EAAQ,QACzBjqD,EAAkB,EAAQ,QAC1B8pD,EAA+B,EAAQ,QAEvCC,EAAsBD,EAA6B,SAEnDz2C,EAAUrT,EAAgB,WAC1BumF,EAAc,GAAGvkF,MACjB0S,EAAM3N,KAAK2N,IAKfzT,EAAE,CAAEM,OAAQ,QAASC,OAAO,EAAM8Q,QAASy3C,GAAuB,CAChE/nD,MAAO,SAAeub,EAAOqvB,GAC3B,IAKIp6B,EAAa3H,EAAQ1G,EALrBxC,EAAIoB,EAAgBnB,MACpBnB,EAASW,EAASO,EAAElB,QACpB4gE,EAAI7X,EAAgBjsC,EAAO9c,GAC3B+lF,EAAMh9B,OAAwB9oD,IAARksC,EAAoBnsC,EAASmsC,EAAKnsC,GAG5D,GAAIib,EAAQ/Z,KACV6Q,EAAc7Q,EAAEyC,YAEU,mBAAfoO,GAA8BA,IAAgB1O,QAAS4X,EAAQlJ,EAAY1P,WAE3Ef,EAASyQ,KAClBA,EAAcA,EAAYa,GACN,OAAhBb,IAAsBA,OAAc9R,IAHxC8R,OAAc9R,EAKZ8R,IAAgB1O,YAAyBpD,IAAhB8R,GAC3B,OAAO+zE,EAAY5lF,KAAKgB,EAAG0/D,EAAGmlB,GAIlC,IADA37E,EAAS,SAAqBnK,IAAhB8R,EAA4B1O,MAAQ0O,GAAakC,EAAI8xE,EAAMnlB,EAAG,IACvEl9D,EAAI,EAAGk9D,EAAImlB,EAAKnlB,IAAKl9D,IAASk9D,KAAK1/D,GAAGsoD,EAAep/C,EAAQ1G,EAAGxC,EAAE0/D,IAEvE,OADAx2D,EAAOpK,OAAS0D,EACT0G,M,qBC3CX,IAAIoiD,EAAgB,EAAQ,QACxBtiD,EAAyB,EAAQ,QAErCxK,EAAOC,QAAU,SAAUoD,GACzB,OAAOypD,EAActiD,EAAuBnH,M,mBCH9CrD,EAAOC,QAAU,CACfqmF,YAAa,EACbC,oBAAqB,EACrBC,aAAc,EACdC,eAAgB,EAChBC,YAAa,EACbC,cAAe,EACfC,aAAc,EACdC,qBAAsB,EACtBC,SAAU,EACVC,kBAAmB,EACnBC,eAAgB,EAChBC,gBAAiB,EACjBC,kBAAmB,EACnBC,UAAW,EACXC,cAAe,EACfC,aAAc,EACdC,SAAU,EACVC,iBAAkB,EAClBC,OAAQ,EACRC,YAAa,EACbC,cAAe,EACfC,cAAe,EACfC,eAAgB,EAChBC,aAAc,EACdC,cAAe,EACfC,iBAAkB,EAClBC,iBAAkB,EAClBC,eAAgB,EAChBC,iBAAkB,EAClBC,cAAe,EACfC,UAAW,I,qBChCb,IAAItmB,EAAgB,EAAQ,QAE5B9hE,EAAOC,QAAU6hE,IACX7/C,OAAO5M,MACkB,iBAAnB4M,OAAOnO,U,kCCLnB,8DAIMu0E,EAAiB,CACrB3kC,SADqB,QAErBC,OAFqB,QAGrBkqB,MAHqB,QAIrB3/D,KAJqB,QAKrBC,MALqB,QAMrBiwC,IAAK1vC,SAQD,aAAuC,IAApB84B,EAAoB,uDAAvC,GACJ,OAAO,cAAW,CAChBtjC,KADgB,eAEhBmE,MAAOm/B,EAAA,OAAkB,eAAmB6gD,EAArC7gD,GAAiE6gD,IAI7D,OAAArvD,K,qBCzBf,IAAIznB,EAAS,EAAQ,QAErBvR,EAAOC,QAAUsR,EAAOvL","file":"static/js/chunk-vendors.84a48fc6.js","sourcesContent":["var wellKnownSymbol = require('../internals/well-known-symbol');\n\nvar TO_STRING_TAG = wellKnownSymbol('toStringTag');\nvar test = {};\n\ntest[TO_STRING_TAG] = 'z';\n\nmodule.exports = String(test) === '[object z]';\n","var aFunction = require('../internals/a-function');\n\n// optional / simple context binding\nmodule.exports = function (fn, that, length) {\n aFunction(fn);\n if (that === undefined) return fn;\n switch (length) {\n case 0: return function () {\n return fn.call(that);\n };\n case 1: return function (a) {\n return fn.call(that, a);\n };\n case 2: return function (a, b) {\n return fn.call(that, a, b);\n };\n case 3: return function (a, b, c) {\n return fn.call(that, a, b, c);\n };\n }\n return function (/* ...args */) {\n return fn.apply(that, arguments);\n };\n};\n","'use strict';\nvar $ = require('../internals/export');\nvar flattenIntoArray = require('../internals/flatten-into-array');\nvar toObject = require('../internals/to-object');\nvar toLength = require('../internals/to-length');\nvar toInteger = require('../internals/to-integer');\nvar arraySpeciesCreate = require('../internals/array-species-create');\n\n// `Array.prototype.flat` method\n// https://tc39.es/ecma262/#sec-array.prototype.flat\n$({ target: 'Array', proto: true }, {\n flat: function flat(/* depthArg = 1 */) {\n var depthArg = arguments.length ? arguments[0] : undefined;\n var O = toObject(this);\n var sourceLen = toLength(O.length);\n var A = arraySpeciesCreate(O, 0);\n A.length = flattenIntoArray(A, O, O, sourceLen, 0, depthArg === undefined ? 1 : toInteger(depthArg));\n return A;\n }\n});\n","'use strict';\nvar aFunction = require('../internals/a-function');\nvar isObject = require('../internals/is-object');\n\nvar slice = [].slice;\nvar factories = {};\n\nvar construct = function (C, argsLength, args) {\n if (!(argsLength in factories)) {\n for (var list = [], i = 0; i < argsLength; i++) list[i] = 'a[' + i + ']';\n // eslint-disable-next-line no-new-func -- we have no proper alternatives, IE8- only\n factories[argsLength] = Function('C,a', 'return new C(' + list.join(',') + ')');\n } return factories[argsLength](C, args);\n};\n\n// `Function.prototype.bind` method implementation\n// https://tc39.es/ecma262/#sec-function.prototype.bind\nmodule.exports = Function.bind || function bind(that /* , ...args */) {\n var fn = aFunction(this);\n var partArgs = slice.call(arguments, 1);\n var boundFunction = function bound(/* args... */) {\n var args = partArgs.concat(slice.call(arguments));\n return this instanceof boundFunction ? construct(fn, args.length, args) : fn.apply(that, args);\n };\n if (isObject(fn.prototype)) boundFunction.prototype = fn.prototype;\n return boundFunction;\n};\n","/* eslint-disable es/no-object-getownpropertynames -- safe */\nvar toIndexedObject = require('../internals/to-indexed-object');\nvar $getOwnPropertyNames = require('../internals/object-get-own-property-names').f;\n\nvar toString = {}.toString;\n\nvar windowNames = typeof window == 'object' && window && Object.getOwnPropertyNames\n ? Object.getOwnPropertyNames(window) : [];\n\nvar getWindowNames = function (it) {\n try {\n return $getOwnPropertyNames(it);\n } catch (error) {\n return windowNames.slice();\n }\n};\n\n// fallback for IE11 buggy Object.getOwnPropertyNames with iframe and window\nmodule.exports.f = function getOwnPropertyNames(it) {\n return windowNames && toString.call(it) == '[object Window]'\n ? getWindowNames(it)\n : $getOwnPropertyNames(toIndexedObject(it));\n};\n","export default function _arrayLikeToArray(arr, len) {\n if (len == null || len > arr.length) len = arr.length;\n\n for (var i = 0, arr2 = new Array(len); i < len; i++) {\n arr2[i] = arr[i];\n }\n\n return arr2;\n}","import arrayLikeToArray from \"./arrayLikeToArray.js\";\nexport default function _unsupportedIterableToArray(o, minLen) {\n if (!o) return;\n if (typeof o === \"string\") return arrayLikeToArray(o, minLen);\n var n = Object.prototype.toString.call(o).slice(8, -1);\n if (n === \"Object\" && o.constructor) n = o.constructor.name;\n if (n === \"Map\" || n === \"Set\") return Array.from(o);\n if (n === \"Arguments\" || /^(?:Ui|I)nt(?:8|16|32)(?:Clamped)?Array$/.test(n)) return arrayLikeToArray(o, minLen);\n}","var DESCRIPTORS = require('../internals/descriptors');\nvar propertyIsEnumerableModule = require('../internals/object-property-is-enumerable');\nvar createPropertyDescriptor = require('../internals/create-property-descriptor');\nvar toIndexedObject = require('../internals/to-indexed-object');\nvar toPrimitive = require('../internals/to-primitive');\nvar has = require('../internals/has');\nvar IE8_DOM_DEFINE = require('../internals/ie8-dom-define');\n\n// eslint-disable-next-line es/no-object-getownpropertydescriptor -- safe\nvar $getOwnPropertyDescriptor = Object.getOwnPropertyDescriptor;\n\n// `Object.getOwnPropertyDescriptor` method\n// https://tc39.es/ecma262/#sec-object.getownpropertydescriptor\nexports.f = DESCRIPTORS ? $getOwnPropertyDescriptor : function getOwnPropertyDescriptor(O, P) {\n O = toIndexedObject(O);\n P = toPrimitive(P, true);\n if (IE8_DOM_DEFINE) try {\n return $getOwnPropertyDescriptor(O, P);\n } catch (error) { /* empty */ }\n if (has(O, P)) return createPropertyDescriptor(!propertyIsEnumerableModule.f.call(O, P), O[P]);\n};\n","var $ = require('../internals/export');\nvar $values = require('../internals/object-to-array').values;\n\n// `Object.values` method\n// https://tc39.es/ecma262/#sec-object.values\n$({ target: 'Object', stat: true }, {\n values: function values(O) {\n return $values(O);\n }\n});\n","'use strict';\n\nvar defaults = require('./../defaults');\nvar utils = require('./../utils');\nvar InterceptorManager = require('./InterceptorManager');\nvar dispatchRequest = require('./dispatchRequest');\n\n/**\n * Create a new instance of Axios\n *\n * @param {Object} instanceConfig The default config for the instance\n */\nfunction Axios(instanceConfig) {\n this.defaults = instanceConfig;\n this.interceptors = {\n request: new InterceptorManager(),\n response: new InterceptorManager()\n };\n}\n\n/**\n * Dispatch a request\n *\n * @param {Object} config The config specific for this request (merged with this.defaults)\n */\nAxios.prototype.request = function request(config) {\n /*eslint no-param-reassign:0*/\n // Allow for axios('example/url'[, config]) a la fetch API\n if (typeof config === 'string') {\n config = utils.merge({\n url: arguments[0]\n }, arguments[1]);\n }\n\n config = utils.merge(defaults, {method: 'get'}, this.defaults, config);\n config.method = config.method.toLowerCase();\n\n // Hook up interceptors middleware\n var chain = [dispatchRequest, undefined];\n var promise = Promise.resolve(config);\n\n this.interceptors.request.forEach(function unshiftRequestInterceptors(interceptor) {\n chain.unshift(interceptor.fulfilled, interceptor.rejected);\n });\n\n this.interceptors.response.forEach(function pushResponseInterceptors(interceptor) {\n chain.push(interceptor.fulfilled, interceptor.rejected);\n });\n\n while (chain.length) {\n promise = promise.then(chain.shift(), chain.shift());\n }\n\n return promise;\n};\n\n// Provide aliases for supported request methods\nutils.forEach(['delete', 'get', 'head', 'options'], function forEachMethodNoData(method) {\n /*eslint func-names:0*/\n Axios.prototype[method] = function(url, config) {\n return this.request(utils.merge(config || {}, {\n method: method,\n url: url\n }));\n };\n});\n\nutils.forEach(['post', 'put', 'patch'], function forEachMethodWithData(method) {\n /*eslint func-names:0*/\n Axios.prototype[method] = function(url, data, config) {\n return this.request(utils.merge(config || {}, {\n method: method,\n url: url,\n data: data\n }));\n };\n});\n\nmodule.exports = Axios;\n","var toObject = require('../internals/to-object');\n\nvar floor = Math.floor;\nvar replace = ''.replace;\nvar SUBSTITUTION_SYMBOLS = /\\$([$&'`]|\\d{1,2}|<[^>]*>)/g;\nvar SUBSTITUTION_SYMBOLS_NO_NAMED = /\\$([$&'`]|\\d{1,2})/g;\n\n// https://tc39.es/ecma262/#sec-getsubstitution\nmodule.exports = function (matched, str, position, captures, namedCaptures, replacement) {\n var tailPos = position + matched.length;\n var m = captures.length;\n var symbols = SUBSTITUTION_SYMBOLS_NO_NAMED;\n if (namedCaptures !== undefined) {\n namedCaptures = toObject(namedCaptures);\n symbols = SUBSTITUTION_SYMBOLS;\n }\n return replace.call(replacement, symbols, function (match, ch) {\n var capture;\n switch (ch.charAt(0)) {\n case '$': return '$';\n case '&': return matched;\n case '`': return str.slice(0, position);\n case \"'\": return str.slice(tailPos);\n case '<':\n capture = namedCaptures[ch.slice(1, -1)];\n break;\n default: // \\d\\d?\n var n = +ch;\n if (n === 0) return match;\n if (n > m) {\n var f = floor(n / 10);\n if (f === 0) return match;\n if (f <= m) return captures[f - 1] === undefined ? ch.charAt(1) : captures[f - 1] + ch.charAt(1);\n return match;\n }\n capture = captures[n - 1];\n }\n return capture === undefined ? '' : capture;\n });\n};\n","var DESCRIPTORS = require('../internals/descriptors');\nvar fails = require('../internals/fails');\nvar createElement = require('../internals/document-create-element');\n\n// Thank's IE8 for his funny defineProperty\nmodule.exports = !DESCRIPTORS && !fails(function () {\n // eslint-disable-next-line es/no-object-defineproperty -- requied for testing\n return Object.defineProperty(createElement('div'), 'a', {\n get: function () { return 7; }\n }).a != 7;\n});\n","'use strict';\n\n/**\n * Syntactic sugar for invoking a function and expanding an array for arguments.\n *\n * Common use case would be to use `Function.prototype.apply`.\n *\n * ```js\n * function f(x, y, z) {}\n * var args = [1, 2, 3];\n * f.apply(null, args);\n * ```\n *\n * With `spread` this example can be re-written.\n *\n * ```js\n * spread(function(x, y, z) {})([1, 2, 3]);\n * ```\n *\n * @param {Function} callback\n * @returns {Function}\n */\nmodule.exports = function spread(callback) {\n return function wrap(arr) {\n return callback.apply(null, arr);\n };\n};\n","import './VGrid.sass'\n\nimport Vue, { PropOptions } from 'vue'\nimport mergeData from '../../util/mergeData'\nimport { upperFirst } from '../../util/helpers'\n\n// no xs\nconst breakpoints = ['sm', 'md', 'lg', 'xl']\n\nconst ALIGNMENT = ['start', 'end', 'center']\n\nfunction makeProps (prefix: string, def: () => PropOptions) {\n return breakpoints.reduce((props, val) => {\n props[prefix + upperFirst(val)] = def()\n return props\n }, {} as Dictionary)\n}\n\nconst alignValidator = (str: any) => [...ALIGNMENT, 'baseline', 'stretch'].includes(str)\nconst alignProps = makeProps('align', () => ({\n type: String,\n default: null,\n validator: alignValidator,\n}))\n\nconst justifyValidator = (str: any) => [...ALIGNMENT, 'space-between', 'space-around'].includes(str)\nconst justifyProps = makeProps('justify', () => ({\n type: String,\n default: null,\n validator: justifyValidator,\n}))\n\nconst alignContentValidator = (str: any) => [...ALIGNMENT, 'space-between', 'space-around', 'stretch'].includes(str)\nconst alignContentProps = makeProps('alignContent', () => ({\n type: String,\n default: null,\n validator: alignContentValidator,\n}))\n\nconst propMap = {\n align: Object.keys(alignProps),\n justify: Object.keys(justifyProps),\n alignContent: Object.keys(alignContentProps),\n}\n\nconst classMap = {\n align: 'align',\n justify: 'justify',\n alignContent: 'align-content',\n}\n\nfunction breakpointClass (type: keyof typeof propMap, prop: string, val: string) {\n let className = classMap[type]\n if (val == null) {\n return undefined\n }\n if (prop) {\n // alignSm -> Sm\n const breakpoint = prop.replace(type, '')\n className += `-${breakpoint}`\n }\n // .align-items-sm-center\n className += `-${val}`\n return className.toLowerCase()\n}\n\nconst cache = new Map()\n\nexport default Vue.extend({\n name: 'v-row',\n functional: true,\n props: {\n tag: {\n type: String,\n default: 'div',\n },\n dense: Boolean,\n noGutters: Boolean,\n align: {\n type: String,\n default: null,\n validator: alignValidator,\n },\n ...alignProps,\n justify: {\n type: String,\n default: null,\n validator: justifyValidator,\n },\n ...justifyProps,\n alignContent: {\n type: String,\n default: null,\n validator: alignContentValidator,\n },\n ...alignContentProps,\n },\n render (h, { props, data, children }) {\n // Super-fast memoization based on props, 5x faster than JSON.stringify\n let cacheKey = ''\n for (const prop in props) {\n cacheKey += String((props as any)[prop])\n }\n let classList = cache.get(cacheKey)\n\n if (!classList) {\n classList = []\n // Loop through `align`, `justify`, `alignContent` breakpoint props\n let type: keyof typeof propMap\n for (type in propMap) {\n propMap[type].forEach(prop => {\n const value: string = (props as any)[prop]\n const className = breakpointClass(type, prop, value)\n if (className) classList!.push(className)\n })\n }\n\n classList.push({\n 'no-gutters': props.noGutters,\n 'row--dense': props.dense,\n [`align-${props.align}`]: props.align,\n [`justify-${props.justify}`]: props.justify,\n [`align-content-${props.alignContent}`]: props.alignContent,\n })\n\n cache.set(cacheKey, classList)\n }\n\n return h(\n props.tag,\n mergeData(data, {\n staticClass: 'row',\n class: classList,\n }),\n children\n )\n },\n})\n","'use strict';\nvar toInteger = require('../internals/to-integer');\nvar requireObjectCoercible = require('../internals/require-object-coercible');\n\n// `String.prototype.repeat` method implementation\n// https://tc39.es/ecma262/#sec-string.prototype.repeat\nmodule.exports = function repeat(count) {\n var str = String(requireObjectCoercible(this));\n var result = '';\n var n = toInteger(count);\n if (n < 0 || n == Infinity) throw RangeError('Wrong number of repetitions');\n for (;n > 0; (n >>>= 1) && (str += str)) if (n & 1) result += str;\n return result;\n};\n","'use strict';\nvar fixRegExpWellKnownSymbolLogic = require('../internals/fix-regexp-well-known-symbol-logic');\nvar isRegExp = require('../internals/is-regexp');\nvar anObject = require('../internals/an-object');\nvar requireObjectCoercible = require('../internals/require-object-coercible');\nvar speciesConstructor = require('../internals/species-constructor');\nvar advanceStringIndex = require('../internals/advance-string-index');\nvar toLength = require('../internals/to-length');\nvar callRegExpExec = require('../internals/regexp-exec-abstract');\nvar regexpExec = require('../internals/regexp-exec');\nvar stickyHelpers = require('../internals/regexp-sticky-helpers');\n\nvar UNSUPPORTED_Y = stickyHelpers.UNSUPPORTED_Y;\nvar arrayPush = [].push;\nvar min = Math.min;\nvar MAX_UINT32 = 0xFFFFFFFF;\n\n// @@split logic\nfixRegExpWellKnownSymbolLogic('split', 2, function (SPLIT, nativeSplit, maybeCallNative) {\n var internalSplit;\n if (\n 'abbc'.split(/(b)*/)[1] == 'c' ||\n // eslint-disable-next-line regexp/no-empty-group -- required for testing\n 'test'.split(/(?:)/, -1).length != 4 ||\n 'ab'.split(/(?:ab)*/).length != 2 ||\n '.'.split(/(.?)(.?)/).length != 4 ||\n // eslint-disable-next-line regexp/no-assertion-capturing-group, regexp/no-empty-group -- required for testing\n '.'.split(/()()/).length > 1 ||\n ''.split(/.?/).length\n ) {\n // based on es5-shim implementation, need to rework it\n internalSplit = function (separator, limit) {\n var string = String(requireObjectCoercible(this));\n var lim = limit === undefined ? MAX_UINT32 : limit >>> 0;\n if (lim === 0) return [];\n if (separator === undefined) return [string];\n // If `separator` is not a regex, use native split\n if (!isRegExp(separator)) {\n return nativeSplit.call(string, separator, lim);\n }\n var output = [];\n var flags = (separator.ignoreCase ? 'i' : '') +\n (separator.multiline ? 'm' : '') +\n (separator.unicode ? 'u' : '') +\n (separator.sticky ? 'y' : '');\n var lastLastIndex = 0;\n // Make `global` and avoid `lastIndex` issues by working with a copy\n var separatorCopy = new RegExp(separator.source, flags + 'g');\n var match, lastIndex, lastLength;\n while (match = regexpExec.call(separatorCopy, string)) {\n lastIndex = separatorCopy.lastIndex;\n if (lastIndex > lastLastIndex) {\n output.push(string.slice(lastLastIndex, match.index));\n if (match.length > 1 && match.index < string.length) arrayPush.apply(output, match.slice(1));\n lastLength = match[0].length;\n lastLastIndex = lastIndex;\n if (output.length >= lim) break;\n }\n if (separatorCopy.lastIndex === match.index) separatorCopy.lastIndex++; // Avoid an infinite loop\n }\n if (lastLastIndex === string.length) {\n if (lastLength || !separatorCopy.test('')) output.push('');\n } else output.push(string.slice(lastLastIndex));\n return output.length > lim ? output.slice(0, lim) : output;\n };\n // Chakra, V8\n } else if ('0'.split(undefined, 0).length) {\n internalSplit = function (separator, limit) {\n return separator === undefined && limit === 0 ? [] : nativeSplit.call(this, separator, limit);\n };\n } else internalSplit = nativeSplit;\n\n return [\n // `String.prototype.split` method\n // https://tc39.es/ecma262/#sec-string.prototype.split\n function split(separator, limit) {\n var O = requireObjectCoercible(this);\n var splitter = separator == undefined ? undefined : separator[SPLIT];\n return splitter !== undefined\n ? splitter.call(separator, O, limit)\n : internalSplit.call(String(O), separator, limit);\n },\n // `RegExp.prototype[@@split]` method\n // https://tc39.es/ecma262/#sec-regexp.prototype-@@split\n //\n // NOTE: This cannot be properly polyfilled in engines that don't support\n // the 'y' flag.\n function (regexp, limit) {\n var res = maybeCallNative(internalSplit, regexp, this, limit, internalSplit !== nativeSplit);\n if (res.done) return res.value;\n\n var rx = anObject(regexp);\n var S = String(this);\n var C = speciesConstructor(rx, RegExp);\n\n var unicodeMatching = rx.unicode;\n var flags = (rx.ignoreCase ? 'i' : '') +\n (rx.multiline ? 'm' : '') +\n (rx.unicode ? 'u' : '') +\n (UNSUPPORTED_Y ? 'g' : 'y');\n\n // ^(? + rx + ) is needed, in combination with some S slicing, to\n // simulate the 'y' flag.\n var splitter = new C(UNSUPPORTED_Y ? '^(?:' + rx.source + ')' : rx, flags);\n var lim = limit === undefined ? MAX_UINT32 : limit >>> 0;\n if (lim === 0) return [];\n if (S.length === 0) return callRegExpExec(splitter, S) === null ? [S] : [];\n var p = 0;\n var q = 0;\n var A = [];\n while (q < S.length) {\n splitter.lastIndex = UNSUPPORTED_Y ? 0 : q;\n var z = callRegExpExec(splitter, UNSUPPORTED_Y ? S.slice(q) : S);\n var e;\n if (\n z === null ||\n (e = min(toLength(splitter.lastIndex + (UNSUPPORTED_Y ? q : 0)), S.length)) === p\n ) {\n q = advanceStringIndex(S, q, unicodeMatching);\n } else {\n A.push(S.slice(p, q));\n if (A.length === lim) return A;\n for (var i = 1; i <= z.length - 1; i++) {\n A.push(z[i]);\n if (A.length === lim) return A;\n }\n q = p = e;\n }\n }\n A.push(S.slice(p));\n return A;\n }\n ];\n}, UNSUPPORTED_Y);\n","import './VIcon.sass'\n\n// Mixins\nimport BindsAttrs from '../../mixins/binds-attrs'\nimport Colorable from '../../mixins/colorable'\nimport Sizeable from '../../mixins/sizeable'\nimport Themeable from '../../mixins/themeable'\n\n// Util\nimport { convertToUnit, keys, remapInternalIcon } from '../../util/helpers'\n\n// Types\nimport Vue, { CreateElement, VNode, VNodeChildren, VNodeData } from 'vue'\nimport mixins from '../../util/mixins'\nimport { VuetifyIcon, VuetifyIconComponent } from 'vuetify/types/services/icons'\n\nenum SIZE_MAP {\n xSmall = '12px',\n small = '16px',\n default = '24px',\n medium = '28px',\n large = '36px',\n xLarge = '40px'\n}\n\nfunction isFontAwesome5 (iconType: string): boolean {\n return ['fas', 'far', 'fal', 'fab', 'fad'].some(val => iconType.includes(val))\n}\n\nfunction isSvgPath (icon: string): boolean {\n return (/^[mzlhvcsqta]\\s*[-+.0-9][^mlhvzcsqta]+/i.test(icon) && /[\\dz]$/i.test(icon) && icon.length > 4)\n}\n\nconst VIcon = mixins(\n BindsAttrs,\n Colorable,\n Sizeable,\n Themeable\n /* @vue/component */\n).extend({\n name: 'v-icon',\n\n props: {\n dense: Boolean,\n disabled: Boolean,\n left: Boolean,\n right: Boolean,\n size: [Number, String],\n tag: {\n type: String,\n required: false,\n default: 'i',\n },\n },\n\n computed: {\n medium () {\n return false\n },\n hasClickListener (): boolean {\n return Boolean(\n this.listeners$.click || this.listeners$['!click']\n )\n },\n },\n\n methods: {\n getIcon (): VuetifyIcon {\n let iconName = ''\n if (this.$slots.default) iconName = this.$slots.default[0].text!.trim()\n\n return remapInternalIcon(this, iconName)\n },\n getSize (): string | undefined {\n const sizes = {\n xSmall: this.xSmall,\n small: this.small,\n medium: this.medium,\n large: this.large,\n xLarge: this.xLarge,\n }\n\n const explicitSize = keys(sizes).find(key => sizes[key])\n\n return (\n (explicitSize && SIZE_MAP[explicitSize]) || convertToUnit(this.size)\n )\n },\n // Component data for both font icon and SVG wrapper span\n getDefaultData (): VNodeData {\n return {\n staticClass: 'v-icon notranslate',\n class: {\n 'v-icon--disabled': this.disabled,\n 'v-icon--left': this.left,\n 'v-icon--link': this.hasClickListener,\n 'v-icon--right': this.right,\n 'v-icon--dense': this.dense,\n },\n attrs: {\n 'aria-hidden': !this.hasClickListener,\n disabled: this.hasClickListener && this.disabled,\n type: this.hasClickListener ? 'button' : undefined,\n ...this.attrs$,\n },\n on: this.listeners$,\n }\n },\n getSvgWrapperData () {\n const fontSize = this.getSize()\n const wrapperData = {\n ...this.getDefaultData(),\n style: fontSize ? {\n fontSize,\n height: fontSize,\n width: fontSize,\n } : undefined,\n }\n this.applyColors(wrapperData)\n\n return wrapperData\n },\n applyColors (data: VNodeData): void {\n data.class = { ...data.class, ...this.themeClasses }\n this.setTextColor(this.color, data)\n },\n renderFontIcon (icon: string, h: CreateElement): VNode {\n const newChildren: VNodeChildren = []\n const data = this.getDefaultData()\n\n let iconType = 'material-icons'\n // Material Icon delimiter is _\n // https://material.io/icons/\n const delimiterIndex = icon.indexOf('-')\n const isMaterialIcon = delimiterIndex <= -1\n\n if (isMaterialIcon) {\n // Material icon uses ligatures.\n newChildren.push(icon)\n } else {\n iconType = icon.slice(0, delimiterIndex)\n if (isFontAwesome5(iconType)) iconType = ''\n }\n\n data.class[iconType] = true\n data.class[icon] = !isMaterialIcon\n\n const fontSize = this.getSize()\n if (fontSize) data.style = { fontSize }\n\n this.applyColors(data)\n\n return h(this.hasClickListener ? 'button' : this.tag, data, newChildren)\n },\n renderSvgIcon (icon: string, h: CreateElement): VNode {\n const svgData: VNodeData = {\n class: 'v-icon__svg',\n attrs: {\n xmlns: 'http://www.w3.org/2000/svg',\n viewBox: '0 0 24 24',\n role: 'img',\n 'aria-hidden': true,\n },\n }\n\n const size = this.getSize()\n if (size) {\n svgData.style = {\n fontSize: size,\n height: size,\n width: size,\n }\n }\n\n return h(this.hasClickListener ? 'button' : 'span', this.getSvgWrapperData(), [\n h('svg', svgData, [\n h('path', {\n attrs: {\n d: icon,\n },\n }),\n ]),\n ])\n },\n renderSvgIconComponent (\n icon: VuetifyIconComponent,\n h: CreateElement\n ): VNode {\n const data: VNodeData = {\n class: {\n 'v-icon__component': true,\n },\n }\n\n const size = this.getSize()\n if (size) {\n data.style = {\n fontSize: size,\n height: size,\n width: size,\n }\n }\n\n this.applyColors(data)\n\n const component = icon.component\n data.props = icon.props\n data.nativeOn = data.on\n\n return h(this.hasClickListener ? 'button' : 'span', this.getSvgWrapperData(), [\n h(component, data),\n ])\n },\n },\n\n render (h: CreateElement): VNode {\n const icon = this.getIcon()\n\n if (typeof icon === 'string') {\n if (isSvgPath(icon)) {\n return this.renderSvgIcon(icon, h)\n }\n return this.renderFontIcon(icon, h)\n }\n\n return this.renderSvgIconComponent(icon, h)\n },\n})\n\nexport default Vue.extend({\n name: 'v-icon',\n\n $_wrapperFor: VIcon,\n\n functional: true,\n\n render (h, { data, children }): VNode {\n let iconName = ''\n\n // Support usage of v-text and v-html\n if (data.domProps) {\n iconName = data.domProps.textContent ||\n data.domProps.innerHTML ||\n iconName\n\n // Remove nodes so it doesn't\n // overwrite our changes\n delete data.domProps.textContent\n delete data.domProps.innerHTML\n }\n\n return h(VIcon, data, iconName ? [iconName] : children)\n },\n})\n","var classof = require('./classof-raw');\nvar regexpExec = require('./regexp-exec');\n\n// `RegExpExec` abstract operation\n// https://tc39.es/ecma262/#sec-regexpexec\nmodule.exports = function (R, S) {\n var exec = R.exec;\n if (typeof exec === 'function') {\n var result = exec.call(R, S);\n if (typeof result !== 'object') {\n throw TypeError('RegExp exec method returned something other than an Object or null');\n }\n return result;\n }\n\n if (classof(R) !== 'RegExp') {\n throw TypeError('RegExp#exec called on incompatible receiver');\n }\n\n return regexpExec.call(R, S);\n};\n\n","var global = require('../internals/global');\nvar DOMIterables = require('../internals/dom-iterables');\nvar forEach = require('../internals/array-for-each');\nvar createNonEnumerableProperty = require('../internals/create-non-enumerable-property');\n\nfor (var COLLECTION_NAME in DOMIterables) {\n var Collection = global[COLLECTION_NAME];\n var CollectionPrototype = Collection && Collection.prototype;\n // some Chrome versions have non-configurable methods on DOMTokenList\n if (CollectionPrototype && CollectionPrototype.forEach !== forEach) try {\n createNonEnumerableProperty(CollectionPrototype, 'forEach', forEach);\n } catch (error) {\n CollectionPrototype.forEach = forEach;\n }\n}\n","'use strict';\nvar $forEach = require('../internals/array-iteration').forEach;\nvar arrayMethodIsStrict = require('../internals/array-method-is-strict');\n\nvar STRICT_METHOD = arrayMethodIsStrict('forEach');\n\n// `Array.prototype.forEach` method implementation\n// https://tc39.es/ecma262/#sec-array.prototype.foreach\nmodule.exports = !STRICT_METHOD ? function forEach(callbackfn /* , thisArg */) {\n return $forEach(this, callbackfn, arguments.length > 1 ? arguments[1] : undefined);\n// eslint-disable-next-line es/no-array-prototype-foreach -- safe\n} : [].forEach;\n","'use strict';\nvar $ = require('../internals/export');\nvar createHTML = require('../internals/create-html');\nvar forcedStringHTMLMethod = require('../internals/string-html-forced');\n\n// `String.prototype.anchor` method\n// https://tc39.es/ecma262/#sec-string.prototype.anchor\n$({ target: 'String', proto: true, forced: forcedStringHTMLMethod('anchor') }, {\n anchor: function anchor(name) {\n return createHTML(this, 'a', 'name', name);\n }\n});\n","module.exports = function (it, Constructor, name) {\n if (!(it instanceof Constructor)) {\n throw TypeError('Incorrect ' + (name ? name + ' ' : '') + 'invocation');\n } return it;\n};\n","var getBuiltIn = require('../internals/get-built-in');\n\nmodule.exports = getBuiltIn('document', 'documentElement');\n","module.exports = function (it) {\n if (typeof it != 'function') {\n throw TypeError(String(it) + ' is not a function');\n } return it;\n};\n","var wellKnownSymbol = require('../internals/well-known-symbol');\n\nvar ITERATOR = wellKnownSymbol('iterator');\nvar SAFE_CLOSING = false;\n\ntry {\n var called = 0;\n var iteratorWithReturn = {\n next: function () {\n return { done: !!called++ };\n },\n 'return': function () {\n SAFE_CLOSING = true;\n }\n };\n iteratorWithReturn[ITERATOR] = function () {\n return this;\n };\n // eslint-disable-next-line es/no-array-from, no-throw-literal -- required for testing\n Array.from(iteratorWithReturn, function () { throw 2; });\n} catch (error) { /* empty */ }\n\nmodule.exports = function (exec, SKIP_CLOSING) {\n if (!SKIP_CLOSING && !SAFE_CLOSING) return false;\n var ITERATION_SUPPORT = false;\n try {\n var object = {};\n object[ITERATOR] = function () {\n return {\n next: function () {\n return { done: ITERATION_SUPPORT = true };\n }\n };\n };\n exec(object);\n } catch (error) { /* empty */ }\n return ITERATION_SUPPORT;\n};\n","var userAgent = require('../internals/engine-user-agent');\n\nmodule.exports = /(?:iphone|ipod|ipad).*applewebkit/i.test(userAgent);\n","'use strict';\n\nmodule.exports = function bind(fn, thisArg) {\n return function wrap() {\n var args = new Array(arguments.length);\n for (var i = 0; i < args.length; i++) {\n args[i] = arguments[i];\n }\n return fn.apply(thisArg, args);\n };\n};\n","// `RequireObjectCoercible` abstract operation\n// https://tc39.es/ecma262/#sec-requireobjectcoercible\nmodule.exports = function (it) {\n if (it == undefined) throw TypeError(\"Can't call method on \" + it);\n return it;\n};\n","var fails = require('../internals/fails');\nvar wellKnownSymbol = require('../internals/well-known-symbol');\nvar V8_VERSION = require('../internals/engine-v8-version');\n\nvar SPECIES = wellKnownSymbol('species');\n\nmodule.exports = function (METHOD_NAME) {\n // We can't use this feature detection in V8 since it causes\n // deoptimization and serious performance degradation\n // https://github.com/zloirock/core-js/issues/677\n return V8_VERSION >= 51 || !fails(function () {\n var array = [];\n var constructor = array.constructor = {};\n constructor[SPECIES] = function () {\n return { foo: 1 };\n };\n return array[METHOD_NAME](Boolean).foo !== 1;\n });\n};\n","var anObject = require('../internals/an-object');\nvar isArrayIteratorMethod = require('../internals/is-array-iterator-method');\nvar toLength = require('../internals/to-length');\nvar bind = require('../internals/function-bind-context');\nvar getIteratorMethod = require('../internals/get-iterator-method');\nvar iteratorClose = require('../internals/iterator-close');\n\nvar Result = function (stopped, result) {\n this.stopped = stopped;\n this.result = result;\n};\n\nmodule.exports = function (iterable, unboundFunction, options) {\n var that = options && options.that;\n var AS_ENTRIES = !!(options && options.AS_ENTRIES);\n var IS_ITERATOR = !!(options && options.IS_ITERATOR);\n var INTERRUPTED = !!(options && options.INTERRUPTED);\n var fn = bind(unboundFunction, that, 1 + AS_ENTRIES + INTERRUPTED);\n var iterator, iterFn, index, length, result, next, step;\n\n var stop = function (condition) {\n if (iterator) iteratorClose(iterator);\n return new Result(true, condition);\n };\n\n var callFn = function (value) {\n if (AS_ENTRIES) {\n anObject(value);\n return INTERRUPTED ? fn(value[0], value[1], stop) : fn(value[0], value[1]);\n } return INTERRUPTED ? fn(value, stop) : fn(value);\n };\n\n if (IS_ITERATOR) {\n iterator = iterable;\n } else {\n iterFn = getIteratorMethod(iterable);\n if (typeof iterFn != 'function') throw TypeError('Target is not iterable');\n // optimisation for array iterators\n if (isArrayIteratorMethod(iterFn)) {\n for (index = 0, length = toLength(iterable.length); length > index; index++) {\n result = callFn(iterable[index]);\n if (result && result instanceof Result) return result;\n } return new Result(false);\n }\n iterator = iterFn.call(iterable);\n }\n\n next = iterator.next;\n while (!(step = next.call(iterator)).done) {\n try {\n result = callFn(step.value);\n } catch (error) {\n iteratorClose(iterator);\n throw error;\n }\n if (typeof result == 'object' && result && result instanceof Result) return result;\n } return new Result(false);\n};\n","var toInteger = require('../internals/to-integer');\n\nvar max = Math.max;\nvar min = Math.min;\n\n// Helper for a popular repeating case of the spec:\n// Let integer be ? ToInteger(index).\n// If integer < 0, let result be max((length + integer), 0); else let result be min(integer, length).\nmodule.exports = function (index, length) {\n var integer = toInteger(index);\n return integer < 0 ? max(integer + length, 0) : min(integer, length);\n};\n","var global = require('../internals/global');\nvar getOwnPropertyDescriptor = require('../internals/object-get-own-property-descriptor').f;\nvar createNonEnumerableProperty = require('../internals/create-non-enumerable-property');\nvar redefine = require('../internals/redefine');\nvar setGlobal = require('../internals/set-global');\nvar copyConstructorProperties = require('../internals/copy-constructor-properties');\nvar isForced = require('../internals/is-forced');\n\n/*\n options.target - name of the target object\n options.global - target is the global object\n options.stat - export as static methods of target\n options.proto - export as prototype methods of target\n options.real - real prototype method for the `pure` version\n options.forced - export even if the native feature is available\n options.bind - bind methods to the target, required for the `pure` version\n options.wrap - wrap constructors to preventing global pollution, required for the `pure` version\n options.unsafe - use the simple assignment of property instead of delete + defineProperty\n options.sham - add a flag to not completely full polyfills\n options.enumerable - export as enumerable property\n options.noTargetGet - prevent calling a getter on target\n*/\nmodule.exports = function (options, source) {\n var TARGET = options.target;\n var GLOBAL = options.global;\n var STATIC = options.stat;\n var FORCED, target, key, targetProperty, sourceProperty, descriptor;\n if (GLOBAL) {\n target = global;\n } else if (STATIC) {\n target = global[TARGET] || setGlobal(TARGET, {});\n } else {\n target = (global[TARGET] || {}).prototype;\n }\n if (target) for (key in source) {\n sourceProperty = source[key];\n if (options.noTargetGet) {\n descriptor = getOwnPropertyDescriptor(target, key);\n targetProperty = descriptor && descriptor.value;\n } else targetProperty = target[key];\n FORCED = isForced(GLOBAL ? key : TARGET + (STATIC ? '.' : '#') + key, options.forced);\n // contained in target\n if (!FORCED && targetProperty !== undefined) {\n if (typeof sourceProperty === typeof targetProperty) continue;\n copyConstructorProperties(sourceProperty, targetProperty);\n }\n // add a flag to not completely full polyfills\n if (options.sham || (targetProperty && targetProperty.sham)) {\n createNonEnumerableProperty(sourceProperty, 'sham', true);\n }\n // extend global\n redefine(target, key, sourceProperty, options);\n }\n};\n","var internalObjectKeys = require('../internals/object-keys-internal');\nvar enumBugKeys = require('../internals/enum-bug-keys');\n\nvar hiddenKeys = enumBugKeys.concat('length', 'prototype');\n\n// `Object.getOwnPropertyNames` method\n// https://tc39.es/ecma262/#sec-object.getownpropertynames\n// eslint-disable-next-line es/no-object-getownpropertynames -- safe\nexports.f = Object.getOwnPropertyNames || function getOwnPropertyNames(O) {\n return internalObjectKeys(O, hiddenKeys);\n};\n","'use strict';\n\nvar utils = require('./utils');\nvar normalizeHeaderName = require('./helpers/normalizeHeaderName');\n\nvar DEFAULT_CONTENT_TYPE = {\n 'Content-Type': 'application/x-www-form-urlencoded'\n};\n\nfunction setContentTypeIfUnset(headers, value) {\n if (!utils.isUndefined(headers) && utils.isUndefined(headers['Content-Type'])) {\n headers['Content-Type'] = value;\n }\n}\n\nfunction getDefaultAdapter() {\n var adapter;\n if (typeof XMLHttpRequest !== 'undefined') {\n // For browsers use XHR adapter\n adapter = require('./adapters/xhr');\n } else if (typeof process !== 'undefined') {\n // For node use HTTP adapter\n adapter = require('./adapters/http');\n }\n return adapter;\n}\n\nvar defaults = {\n adapter: getDefaultAdapter(),\n\n transformRequest: [function transformRequest(data, headers) {\n normalizeHeaderName(headers, 'Content-Type');\n if (utils.isFormData(data) ||\n utils.isArrayBuffer(data) ||\n utils.isBuffer(data) ||\n utils.isStream(data) ||\n utils.isFile(data) ||\n utils.isBlob(data)\n ) {\n return data;\n }\n if (utils.isArrayBufferView(data)) {\n return data.buffer;\n }\n if (utils.isURLSearchParams(data)) {\n setContentTypeIfUnset(headers, 'application/x-www-form-urlencoded;charset=utf-8');\n return data.toString();\n }\n if (utils.isObject(data)) {\n setContentTypeIfUnset(headers, 'application/json;charset=utf-8');\n return JSON.stringify(data);\n }\n return data;\n }],\n\n transformResponse: [function transformResponse(data) {\n /*eslint no-param-reassign:0*/\n if (typeof data === 'string') {\n try {\n data = JSON.parse(data);\n } catch (e) { /* Ignore */ }\n }\n return data;\n }],\n\n /**\n * A timeout in milliseconds to abort a request. If set to 0 (default) a\n * timeout is not created.\n */\n timeout: 0,\n\n xsrfCookieName: 'XSRF-TOKEN',\n xsrfHeaderName: 'X-XSRF-TOKEN',\n\n maxContentLength: -1,\n\n validateStatus: function validateStatus(status) {\n return status >= 200 && status < 300;\n }\n};\n\ndefaults.headers = {\n common: {\n 'Accept': 'application/json, text/plain, */*'\n }\n};\n\nutils.forEach(['delete', 'get', 'head'], function forEachMethodNoData(method) {\n defaults.headers[method] = {};\n});\n\nutils.forEach(['post', 'put', 'patch'], function forEachMethodWithData(method) {\n defaults.headers[method] = utils.merge(DEFAULT_CONTENT_TYPE);\n});\n\nmodule.exports = defaults;\n","// Helpers\nimport { convertToUnit } from '../../util/helpers'\n\n// Types\nimport Vue, { PropType } from 'vue'\n\nexport type NumberOrNumberString = PropType\n\nexport default Vue.extend({\n name: 'measurable',\n\n props: {\n height: [Number, String] as NumberOrNumberString,\n maxHeight: [Number, String] as NumberOrNumberString,\n maxWidth: [Number, String] as NumberOrNumberString,\n minHeight: [Number, String] as NumberOrNumberString,\n minWidth: [Number, String] as NumberOrNumberString,\n width: [Number, String] as NumberOrNumberString,\n },\n\n computed: {\n measurableStyles (): object {\n const styles: Record = {}\n\n const height = convertToUnit(this.height)\n const minHeight = convertToUnit(this.minHeight)\n const minWidth = convertToUnit(this.minWidth)\n const maxHeight = convertToUnit(this.maxHeight)\n const maxWidth = convertToUnit(this.maxWidth)\n const width = convertToUnit(this.width)\n\n if (height) styles.height = height\n if (minHeight) styles.minHeight = minHeight\n if (minWidth) styles.minWidth = minWidth\n if (maxHeight) styles.maxHeight = maxHeight\n if (maxWidth) styles.maxWidth = maxWidth\n if (width) styles.width = width\n\n return styles\n },\n },\n})\n","'use strict';\nvar $ = require('../internals/export');\nvar notARegExp = require('../internals/not-a-regexp');\nvar requireObjectCoercible = require('../internals/require-object-coercible');\nvar correctIsRegExpLogic = require('../internals/correct-is-regexp-logic');\n\n// `String.prototype.includes` method\n// https://tc39.es/ecma262/#sec-string.prototype.includes\n$({ target: 'String', proto: true, forced: !correctIsRegExpLogic('includes') }, {\n includes: function includes(searchString /* , position = 0 */) {\n return !!~String(requireObjectCoercible(this))\n .indexOf(notARegExp(searchString), arguments.length > 1 ? arguments[1] : undefined);\n }\n});\n","'use strict';\nvar redefine = require('../internals/redefine');\nvar anObject = require('../internals/an-object');\nvar fails = require('../internals/fails');\nvar flags = require('../internals/regexp-flags');\n\nvar TO_STRING = 'toString';\nvar RegExpPrototype = RegExp.prototype;\nvar nativeToString = RegExpPrototype[TO_STRING];\n\nvar NOT_GENERIC = fails(function () { return nativeToString.call({ source: 'a', flags: 'b' }) != '/a/b'; });\n// FF44- RegExp#toString has a wrong name\nvar INCORRECT_NAME = nativeToString.name != TO_STRING;\n\n// `RegExp.prototype.toString` method\n// https://tc39.es/ecma262/#sec-regexp.prototype.tostring\nif (NOT_GENERIC || INCORRECT_NAME) {\n redefine(RegExp.prototype, TO_STRING, function toString() {\n var R = anObject(this);\n var p = String(R.source);\n var rf = R.flags;\n var f = String(rf === undefined && R instanceof RegExp && !('flags' in RegExpPrototype) ? flags.call(R) : rf);\n return '/' + p + '/' + f;\n }, { unsafe: true });\n}\n","'use strict';\nvar getBuiltIn = require('../internals/get-built-in');\nvar definePropertyModule = require('../internals/object-define-property');\nvar wellKnownSymbol = require('../internals/well-known-symbol');\nvar DESCRIPTORS = require('../internals/descriptors');\n\nvar SPECIES = wellKnownSymbol('species');\n\nmodule.exports = function (CONSTRUCTOR_NAME) {\n var Constructor = getBuiltIn(CONSTRUCTOR_NAME);\n var defineProperty = definePropertyModule.f;\n\n if (DESCRIPTORS && Constructor && !Constructor[SPECIES]) {\n defineProperty(Constructor, SPECIES, {\n configurable: true,\n get: function () { return this; }\n });\n }\n};\n","/* globals __VUE_SSR_CONTEXT__ */\n\n// IMPORTANT: Do NOT use ES2015 features in this file (except for modules).\n// This module is a runtime utility for cleaner component module output and will\n// be included in the final webpack user bundle.\n\nexport default function normalizeComponent (\n scriptExports,\n render,\n staticRenderFns,\n functionalTemplate,\n injectStyles,\n scopeId,\n moduleIdentifier, /* server only */\n shadowMode /* vue-cli only */\n) {\n // Vue.extend constructor export interop\n var options = typeof scriptExports === 'function'\n ? scriptExports.options\n : scriptExports\n\n // render functions\n if (render) {\n options.render = render\n options.staticRenderFns = staticRenderFns\n options._compiled = true\n }\n\n // functional template\n if (functionalTemplate) {\n options.functional = true\n }\n\n // scopedId\n if (scopeId) {\n options._scopeId = 'data-v-' + scopeId\n }\n\n var hook\n if (moduleIdentifier) { // server build\n hook = function (context) {\n // 2.3 injection\n context =\n context || // cached call\n (this.$vnode && this.$vnode.ssrContext) || // stateful\n (this.parent && this.parent.$vnode && this.parent.$vnode.ssrContext) // functional\n // 2.2 with runInNewContext: true\n if (!context && typeof __VUE_SSR_CONTEXT__ !== 'undefined') {\n context = __VUE_SSR_CONTEXT__\n }\n // inject component styles\n if (injectStyles) {\n injectStyles.call(this, context)\n }\n // register component module identifier for async chunk inferrence\n if (context && context._registeredComponents) {\n context._registeredComponents.add(moduleIdentifier)\n }\n }\n // used by ssr in case component is cached and beforeCreate\n // never gets called\n options._ssrRegister = hook\n } else if (injectStyles) {\n hook = shadowMode\n ? function () {\n injectStyles.call(\n this,\n (options.functional ? this.parent : this).$root.$options.shadowRoot\n )\n }\n : injectStyles\n }\n\n if (hook) {\n if (options.functional) {\n // for template-only hot-reload because in that case the render fn doesn't\n // go through the normalizer\n options._injectStyles = hook\n // register for functional component in vue file\n var originalRender = options.render\n options.render = function renderWithStyleInjection (h, context) {\n hook.call(context)\n return originalRender(h, context)\n }\n } else {\n // inject component registration as beforeCreate hook\n var existing = options.beforeCreate\n options.beforeCreate = existing\n ? [].concat(existing, hook)\n : [hook]\n }\n }\n\n return {\n exports: scriptExports,\n options: options\n }\n}\n","var anObject = require('../internals/an-object');\n\nmodule.exports = function (iterator) {\n var returnMethod = iterator['return'];\n if (returnMethod !== undefined) {\n return anObject(returnMethod.call(iterator)).value;\n }\n};\n","/*!\n * Vue.js v2.6.12\n * (c) 2014-2020 Evan You\n * Released under the MIT License.\n */\n/* */\n\nvar emptyObject = Object.freeze({});\n\n// These helpers produce better VM code in JS engines due to their\n// explicitness and function inlining.\nfunction isUndef (v) {\n return v === undefined || v === null\n}\n\nfunction isDef (v) {\n return v !== undefined && v !== null\n}\n\nfunction isTrue (v) {\n return v === true\n}\n\nfunction isFalse (v) {\n return v === false\n}\n\n/**\n * Check if value is primitive.\n */\nfunction isPrimitive (value) {\n return (\n typeof value === 'string' ||\n typeof value === 'number' ||\n // $flow-disable-line\n typeof value === 'symbol' ||\n typeof value === 'boolean'\n )\n}\n\n/**\n * Quick object check - this is primarily used to tell\n * Objects from primitive values when we know the value\n * is a JSON-compliant type.\n */\nfunction isObject (obj) {\n return obj !== null && typeof obj === 'object'\n}\n\n/**\n * Get the raw type string of a value, e.g., [object Object].\n */\nvar _toString = Object.prototype.toString;\n\nfunction toRawType (value) {\n return _toString.call(value).slice(8, -1)\n}\n\n/**\n * Strict object type check. Only returns true\n * for plain JavaScript objects.\n */\nfunction isPlainObject (obj) {\n return _toString.call(obj) === '[object Object]'\n}\n\nfunction isRegExp (v) {\n return _toString.call(v) === '[object RegExp]'\n}\n\n/**\n * Check if val is a valid array index.\n */\nfunction isValidArrayIndex (val) {\n var n = parseFloat(String(val));\n return n >= 0 && Math.floor(n) === n && isFinite(val)\n}\n\nfunction isPromise (val) {\n return (\n isDef(val) &&\n typeof val.then === 'function' &&\n typeof val.catch === 'function'\n )\n}\n\n/**\n * Convert a value to a string that is actually rendered.\n */\nfunction toString (val) {\n return val == null\n ? ''\n : Array.isArray(val) || (isPlainObject(val) && val.toString === _toString)\n ? JSON.stringify(val, null, 2)\n : String(val)\n}\n\n/**\n * Convert an input value to a number for persistence.\n * If the conversion fails, return original string.\n */\nfunction toNumber (val) {\n var n = parseFloat(val);\n return isNaN(n) ? val : n\n}\n\n/**\n * Make a map and return a function for checking if a key\n * is in that map.\n */\nfunction makeMap (\n str,\n expectsLowerCase\n) {\n var map = Object.create(null);\n var list = str.split(',');\n for (var i = 0; i < list.length; i++) {\n map[list[i]] = true;\n }\n return expectsLowerCase\n ? function (val) { return map[val.toLowerCase()]; }\n : function (val) { return map[val]; }\n}\n\n/**\n * Check if a tag is a built-in tag.\n */\nvar isBuiltInTag = makeMap('slot,component', true);\n\n/**\n * Check if an attribute is a reserved attribute.\n */\nvar isReservedAttribute = makeMap('key,ref,slot,slot-scope,is');\n\n/**\n * Remove an item from an array.\n */\nfunction remove (arr, item) {\n if (arr.length) {\n var index = arr.indexOf(item);\n if (index > -1) {\n return arr.splice(index, 1)\n }\n }\n}\n\n/**\n * Check whether an object has the property.\n */\nvar hasOwnProperty = Object.prototype.hasOwnProperty;\nfunction hasOwn (obj, key) {\n return hasOwnProperty.call(obj, key)\n}\n\n/**\n * Create a cached version of a pure function.\n */\nfunction cached (fn) {\n var cache = Object.create(null);\n return (function cachedFn (str) {\n var hit = cache[str];\n return hit || (cache[str] = fn(str))\n })\n}\n\n/**\n * Camelize a hyphen-delimited string.\n */\nvar camelizeRE = /-(\\w)/g;\nvar camelize = cached(function (str) {\n return str.replace(camelizeRE, function (_, c) { return c ? c.toUpperCase() : ''; })\n});\n\n/**\n * Capitalize a string.\n */\nvar capitalize = cached(function (str) {\n return str.charAt(0).toUpperCase() + str.slice(1)\n});\n\n/**\n * Hyphenate a camelCase string.\n */\nvar hyphenateRE = /\\B([A-Z])/g;\nvar hyphenate = cached(function (str) {\n return str.replace(hyphenateRE, '-$1').toLowerCase()\n});\n\n/**\n * Simple bind polyfill for environments that do not support it,\n * e.g., PhantomJS 1.x. Technically, we don't need this anymore\n * since native bind is now performant enough in most browsers.\n * But removing it would mean breaking code that was able to run in\n * PhantomJS 1.x, so this must be kept for backward compatibility.\n */\n\n/* istanbul ignore next */\nfunction polyfillBind (fn, ctx) {\n function boundFn (a) {\n var l = arguments.length;\n return l\n ? l > 1\n ? fn.apply(ctx, arguments)\n : fn.call(ctx, a)\n : fn.call(ctx)\n }\n\n boundFn._length = fn.length;\n return boundFn\n}\n\nfunction nativeBind (fn, ctx) {\n return fn.bind(ctx)\n}\n\nvar bind = Function.prototype.bind\n ? nativeBind\n : polyfillBind;\n\n/**\n * Convert an Array-like object to a real Array.\n */\nfunction toArray (list, start) {\n start = start || 0;\n var i = list.length - start;\n var ret = new Array(i);\n while (i--) {\n ret[i] = list[i + start];\n }\n return ret\n}\n\n/**\n * Mix properties into target object.\n */\nfunction extend (to, _from) {\n for (var key in _from) {\n to[key] = _from[key];\n }\n return to\n}\n\n/**\n * Merge an Array of Objects into a single Object.\n */\nfunction toObject (arr) {\n var res = {};\n for (var i = 0; i < arr.length; i++) {\n if (arr[i]) {\n extend(res, arr[i]);\n }\n }\n return res\n}\n\n/* eslint-disable no-unused-vars */\n\n/**\n * Perform no operation.\n * Stubbing args to make Flow happy without leaving useless transpiled code\n * with ...rest (https://flow.org/blog/2017/05/07/Strict-Function-Call-Arity/).\n */\nfunction noop (a, b, c) {}\n\n/**\n * Always return false.\n */\nvar no = function (a, b, c) { return false; };\n\n/* eslint-enable no-unused-vars */\n\n/**\n * Return the same value.\n */\nvar identity = function (_) { return _; };\n\n/**\n * Check if two values are loosely equal - that is,\n * if they are plain objects, do they have the same shape?\n */\nfunction looseEqual (a, b) {\n if (a === b) { return true }\n var isObjectA = isObject(a);\n var isObjectB = isObject(b);\n if (isObjectA && isObjectB) {\n try {\n var isArrayA = Array.isArray(a);\n var isArrayB = Array.isArray(b);\n if (isArrayA && isArrayB) {\n return a.length === b.length && a.every(function (e, i) {\n return looseEqual(e, b[i])\n })\n } else if (a instanceof Date && b instanceof Date) {\n return a.getTime() === b.getTime()\n } else if (!isArrayA && !isArrayB) {\n var keysA = Object.keys(a);\n var keysB = Object.keys(b);\n return keysA.length === keysB.length && keysA.every(function (key) {\n return looseEqual(a[key], b[key])\n })\n } else {\n /* istanbul ignore next */\n return false\n }\n } catch (e) {\n /* istanbul ignore next */\n return false\n }\n } else if (!isObjectA && !isObjectB) {\n return String(a) === String(b)\n } else {\n return false\n }\n}\n\n/**\n * Return the first index at which a loosely equal value can be\n * found in the array (if value is a plain object, the array must\n * contain an object of the same shape), or -1 if it is not present.\n */\nfunction looseIndexOf (arr, val) {\n for (var i = 0; i < arr.length; i++) {\n if (looseEqual(arr[i], val)) { return i }\n }\n return -1\n}\n\n/**\n * Ensure a function is called only once.\n */\nfunction once (fn) {\n var called = false;\n return function () {\n if (!called) {\n called = true;\n fn.apply(this, arguments);\n }\n }\n}\n\nvar SSR_ATTR = 'data-server-rendered';\n\nvar ASSET_TYPES = [\n 'component',\n 'directive',\n 'filter'\n];\n\nvar LIFECYCLE_HOOKS = [\n 'beforeCreate',\n 'created',\n 'beforeMount',\n 'mounted',\n 'beforeUpdate',\n 'updated',\n 'beforeDestroy',\n 'destroyed',\n 'activated',\n 'deactivated',\n 'errorCaptured',\n 'serverPrefetch'\n];\n\n/* */\n\n\n\nvar config = ({\n /**\n * Option merge strategies (used in core/util/options)\n */\n // $flow-disable-line\n optionMergeStrategies: Object.create(null),\n\n /**\n * Whether to suppress warnings.\n */\n silent: false,\n\n /**\n * Show production mode tip message on boot?\n */\n productionTip: process.env.NODE_ENV !== 'production',\n\n /**\n * Whether to enable devtools\n */\n devtools: process.env.NODE_ENV !== 'production',\n\n /**\n * Whether to record perf\n */\n performance: false,\n\n /**\n * Error handler for watcher errors\n */\n errorHandler: null,\n\n /**\n * Warn handler for watcher warns\n */\n warnHandler: null,\n\n /**\n * Ignore certain custom elements\n */\n ignoredElements: [],\n\n /**\n * Custom user key aliases for v-on\n */\n // $flow-disable-line\n keyCodes: Object.create(null),\n\n /**\n * Check if a tag is reserved so that it cannot be registered as a\n * component. This is platform-dependent and may be overwritten.\n */\n isReservedTag: no,\n\n /**\n * Check if an attribute is reserved so that it cannot be used as a component\n * prop. This is platform-dependent and may be overwritten.\n */\n isReservedAttr: no,\n\n /**\n * Check if a tag is an unknown element.\n * Platform-dependent.\n */\n isUnknownElement: no,\n\n /**\n * Get the namespace of an element\n */\n getTagNamespace: noop,\n\n /**\n * Parse the real tag name for the specific platform.\n */\n parsePlatformTagName: identity,\n\n /**\n * Check if an attribute must be bound using property, e.g. value\n * Platform-dependent.\n */\n mustUseProp: no,\n\n /**\n * Perform updates asynchronously. Intended to be used by Vue Test Utils\n * This will significantly reduce performance if set to false.\n */\n async: true,\n\n /**\n * Exposed for legacy reasons\n */\n _lifecycleHooks: LIFECYCLE_HOOKS\n});\n\n/* */\n\n/**\n * unicode letters used for parsing html tags, component names and property paths.\n * using https://www.w3.org/TR/html53/semantics-scripting.html#potentialcustomelementname\n * skipping \\u10000-\\uEFFFF due to it freezing up PhantomJS\n */\nvar unicodeRegExp = /a-zA-Z\\u00B7\\u00C0-\\u00D6\\u00D8-\\u00F6\\u00F8-\\u037D\\u037F-\\u1FFF\\u200C-\\u200D\\u203F-\\u2040\\u2070-\\u218F\\u2C00-\\u2FEF\\u3001-\\uD7FF\\uF900-\\uFDCF\\uFDF0-\\uFFFD/;\n\n/**\n * Check if a string starts with $ or _\n */\nfunction isReserved (str) {\n var c = (str + '').charCodeAt(0);\n return c === 0x24 || c === 0x5F\n}\n\n/**\n * Define a property.\n */\nfunction def (obj, key, val, enumerable) {\n Object.defineProperty(obj, key, {\n value: val,\n enumerable: !!enumerable,\n writable: true,\n configurable: true\n });\n}\n\n/**\n * Parse simple path.\n */\nvar bailRE = new RegExp((\"[^\" + (unicodeRegExp.source) + \".$_\\\\d]\"));\nfunction parsePath (path) {\n if (bailRE.test(path)) {\n return\n }\n var segments = path.split('.');\n return function (obj) {\n for (var i = 0; i < segments.length; i++) {\n if (!obj) { return }\n obj = obj[segments[i]];\n }\n return obj\n }\n}\n\n/* */\n\n// can we use __proto__?\nvar hasProto = '__proto__' in {};\n\n// Browser environment sniffing\nvar inBrowser = typeof window !== 'undefined';\nvar inWeex = typeof WXEnvironment !== 'undefined' && !!WXEnvironment.platform;\nvar weexPlatform = inWeex && WXEnvironment.platform.toLowerCase();\nvar UA = inBrowser && window.navigator.userAgent.toLowerCase();\nvar isIE = UA && /msie|trident/.test(UA);\nvar isIE9 = UA && UA.indexOf('msie 9.0') > 0;\nvar isEdge = UA && UA.indexOf('edge/') > 0;\nvar isAndroid = (UA && UA.indexOf('android') > 0) || (weexPlatform === 'android');\nvar isIOS = (UA && /iphone|ipad|ipod|ios/.test(UA)) || (weexPlatform === 'ios');\nvar isChrome = UA && /chrome\\/\\d+/.test(UA) && !isEdge;\nvar isPhantomJS = UA && /phantomjs/.test(UA);\nvar isFF = UA && UA.match(/firefox\\/(\\d+)/);\n\n// Firefox has a \"watch\" function on Object.prototype...\nvar nativeWatch = ({}).watch;\n\nvar supportsPassive = false;\nif (inBrowser) {\n try {\n var opts = {};\n Object.defineProperty(opts, 'passive', ({\n get: function get () {\n /* istanbul ignore next */\n supportsPassive = true;\n }\n })); // https://github.com/facebook/flow/issues/285\n window.addEventListener('test-passive', null, opts);\n } catch (e) {}\n}\n\n// this needs to be lazy-evaled because vue may be required before\n// vue-server-renderer can set VUE_ENV\nvar _isServer;\nvar isServerRendering = function () {\n if (_isServer === undefined) {\n /* istanbul ignore if */\n if (!inBrowser && !inWeex && typeof global !== 'undefined') {\n // detect presence of vue-server-renderer and avoid\n // Webpack shimming the process\n _isServer = global['process'] && global['process'].env.VUE_ENV === 'server';\n } else {\n _isServer = false;\n }\n }\n return _isServer\n};\n\n// detect devtools\nvar devtools = inBrowser && window.__VUE_DEVTOOLS_GLOBAL_HOOK__;\n\n/* istanbul ignore next */\nfunction isNative (Ctor) {\n return typeof Ctor === 'function' && /native code/.test(Ctor.toString())\n}\n\nvar hasSymbol =\n typeof Symbol !== 'undefined' && isNative(Symbol) &&\n typeof Reflect !== 'undefined' && isNative(Reflect.ownKeys);\n\nvar _Set;\n/* istanbul ignore if */ // $flow-disable-line\nif (typeof Set !== 'undefined' && isNative(Set)) {\n // use native Set when available.\n _Set = Set;\n} else {\n // a non-standard Set polyfill that only works with primitive keys.\n _Set = /*@__PURE__*/(function () {\n function Set () {\n this.set = Object.create(null);\n }\n Set.prototype.has = function has (key) {\n return this.set[key] === true\n };\n Set.prototype.add = function add (key) {\n this.set[key] = true;\n };\n Set.prototype.clear = function clear () {\n this.set = Object.create(null);\n };\n\n return Set;\n }());\n}\n\n/* */\n\nvar warn = noop;\nvar tip = noop;\nvar generateComponentTrace = (noop); // work around flow check\nvar formatComponentName = (noop);\n\nif (process.env.NODE_ENV !== 'production') {\n var hasConsole = typeof console !== 'undefined';\n var classifyRE = /(?:^|[-_])(\\w)/g;\n var classify = function (str) { return str\n .replace(classifyRE, function (c) { return c.toUpperCase(); })\n .replace(/[-_]/g, ''); };\n\n warn = function (msg, vm) {\n var trace = vm ? generateComponentTrace(vm) : '';\n\n if (config.warnHandler) {\n config.warnHandler.call(null, msg, vm, trace);\n } else if (hasConsole && (!config.silent)) {\n console.error((\"[Vue warn]: \" + msg + trace));\n }\n };\n\n tip = function (msg, vm) {\n if (hasConsole && (!config.silent)) {\n console.warn(\"[Vue tip]: \" + msg + (\n vm ? generateComponentTrace(vm) : ''\n ));\n }\n };\n\n formatComponentName = function (vm, includeFile) {\n if (vm.$root === vm) {\n return ''\n }\n var options = typeof vm === 'function' && vm.cid != null\n ? vm.options\n : vm._isVue\n ? vm.$options || vm.constructor.options\n : vm;\n var name = options.name || options._componentTag;\n var file = options.__file;\n if (!name && file) {\n var match = file.match(/([^/\\\\]+)\\.vue$/);\n name = match && match[1];\n }\n\n return (\n (name ? (\"<\" + (classify(name)) + \">\") : \"\") +\n (file && includeFile !== false ? (\" at \" + file) : '')\n )\n };\n\n var repeat = function (str, n) {\n var res = '';\n while (n) {\n if (n % 2 === 1) { res += str; }\n if (n > 1) { str += str; }\n n >>= 1;\n }\n return res\n };\n\n generateComponentTrace = function (vm) {\n if (vm._isVue && vm.$parent) {\n var tree = [];\n var currentRecursiveSequence = 0;\n while (vm) {\n if (tree.length > 0) {\n var last = tree[tree.length - 1];\n if (last.constructor === vm.constructor) {\n currentRecursiveSequence++;\n vm = vm.$parent;\n continue\n } else if (currentRecursiveSequence > 0) {\n tree[tree.length - 1] = [last, currentRecursiveSequence];\n currentRecursiveSequence = 0;\n }\n }\n tree.push(vm);\n vm = vm.$parent;\n }\n return '\\n\\nfound in\\n\\n' + tree\n .map(function (vm, i) { return (\"\" + (i === 0 ? '---> ' : repeat(' ', 5 + i * 2)) + (Array.isArray(vm)\n ? ((formatComponentName(vm[0])) + \"... (\" + (vm[1]) + \" recursive calls)\")\n : formatComponentName(vm))); })\n .join('\\n')\n } else {\n return (\"\\n\\n(found in \" + (formatComponentName(vm)) + \")\")\n }\n };\n}\n\n/* */\n\nvar uid = 0;\n\n/**\n * A dep is an observable that can have multiple\n * directives subscribing to it.\n */\nvar Dep = function Dep () {\n this.id = uid++;\n this.subs = [];\n};\n\nDep.prototype.addSub = function addSub (sub) {\n this.subs.push(sub);\n};\n\nDep.prototype.removeSub = function removeSub (sub) {\n remove(this.subs, sub);\n};\n\nDep.prototype.depend = function depend () {\n if (Dep.target) {\n Dep.target.addDep(this);\n }\n};\n\nDep.prototype.notify = function notify () {\n // stabilize the subscriber list first\n var subs = this.subs.slice();\n if (process.env.NODE_ENV !== 'production' && !config.async) {\n // subs aren't sorted in scheduler if not running async\n // we need to sort them now to make sure they fire in correct\n // order\n subs.sort(function (a, b) { return a.id - b.id; });\n }\n for (var i = 0, l = subs.length; i < l; i++) {\n subs[i].update();\n }\n};\n\n// The current target watcher being evaluated.\n// This is globally unique because only one watcher\n// can be evaluated at a time.\nDep.target = null;\nvar targetStack = [];\n\nfunction pushTarget (target) {\n targetStack.push(target);\n Dep.target = target;\n}\n\nfunction popTarget () {\n targetStack.pop();\n Dep.target = targetStack[targetStack.length - 1];\n}\n\n/* */\n\nvar VNode = function VNode (\n tag,\n data,\n children,\n text,\n elm,\n context,\n componentOptions,\n asyncFactory\n) {\n this.tag = tag;\n this.data = data;\n this.children = children;\n this.text = text;\n this.elm = elm;\n this.ns = undefined;\n this.context = context;\n this.fnContext = undefined;\n this.fnOptions = undefined;\n this.fnScopeId = undefined;\n this.key = data && data.key;\n this.componentOptions = componentOptions;\n this.componentInstance = undefined;\n this.parent = undefined;\n this.raw = false;\n this.isStatic = false;\n this.isRootInsert = true;\n this.isComment = false;\n this.isCloned = false;\n this.isOnce = false;\n this.asyncFactory = asyncFactory;\n this.asyncMeta = undefined;\n this.isAsyncPlaceholder = false;\n};\n\nvar prototypeAccessors = { child: { configurable: true } };\n\n// DEPRECATED: alias for componentInstance for backwards compat.\n/* istanbul ignore next */\nprototypeAccessors.child.get = function () {\n return this.componentInstance\n};\n\nObject.defineProperties( VNode.prototype, prototypeAccessors );\n\nvar createEmptyVNode = function (text) {\n if ( text === void 0 ) text = '';\n\n var node = new VNode();\n node.text = text;\n node.isComment = true;\n return node\n};\n\nfunction createTextVNode (val) {\n return new VNode(undefined, undefined, undefined, String(val))\n}\n\n// optimized shallow clone\n// used for static nodes and slot nodes because they may be reused across\n// multiple renders, cloning them avoids errors when DOM manipulations rely\n// on their elm reference.\nfunction cloneVNode (vnode) {\n var cloned = new VNode(\n vnode.tag,\n vnode.data,\n // #7975\n // clone children array to avoid mutating original in case of cloning\n // a child.\n vnode.children && vnode.children.slice(),\n vnode.text,\n vnode.elm,\n vnode.context,\n vnode.componentOptions,\n vnode.asyncFactory\n );\n cloned.ns = vnode.ns;\n cloned.isStatic = vnode.isStatic;\n cloned.key = vnode.key;\n cloned.isComment = vnode.isComment;\n cloned.fnContext = vnode.fnContext;\n cloned.fnOptions = vnode.fnOptions;\n cloned.fnScopeId = vnode.fnScopeId;\n cloned.asyncMeta = vnode.asyncMeta;\n cloned.isCloned = true;\n return cloned\n}\n\n/*\n * not type checking this file because flow doesn't play well with\n * dynamically accessing methods on Array prototype\n */\n\nvar arrayProto = Array.prototype;\nvar arrayMethods = Object.create(arrayProto);\n\nvar methodsToPatch = [\n 'push',\n 'pop',\n 'shift',\n 'unshift',\n 'splice',\n 'sort',\n 'reverse'\n];\n\n/**\n * Intercept mutating methods and emit events\n */\nmethodsToPatch.forEach(function (method) {\n // cache original method\n var original = arrayProto[method];\n def(arrayMethods, method, function mutator () {\n var args = [], len = arguments.length;\n while ( len-- ) args[ len ] = arguments[ len ];\n\n var result = original.apply(this, args);\n var ob = this.__ob__;\n var inserted;\n switch (method) {\n case 'push':\n case 'unshift':\n inserted = args;\n break\n case 'splice':\n inserted = args.slice(2);\n break\n }\n if (inserted) { ob.observeArray(inserted); }\n // notify change\n ob.dep.notify();\n return result\n });\n});\n\n/* */\n\nvar arrayKeys = Object.getOwnPropertyNames(arrayMethods);\n\n/**\n * In some cases we may want to disable observation inside a component's\n * update computation.\n */\nvar shouldObserve = true;\n\nfunction toggleObserving (value) {\n shouldObserve = value;\n}\n\n/**\n * Observer class that is attached to each observed\n * object. Once attached, the observer converts the target\n * object's property keys into getter/setters that\n * collect dependencies and dispatch updates.\n */\nvar Observer = function Observer (value) {\n this.value = value;\n this.dep = new Dep();\n this.vmCount = 0;\n def(value, '__ob__', this);\n if (Array.isArray(value)) {\n if (hasProto) {\n protoAugment(value, arrayMethods);\n } else {\n copyAugment(value, arrayMethods, arrayKeys);\n }\n this.observeArray(value);\n } else {\n this.walk(value);\n }\n};\n\n/**\n * Walk through all properties and convert them into\n * getter/setters. This method should only be called when\n * value type is Object.\n */\nObserver.prototype.walk = function walk (obj) {\n var keys = Object.keys(obj);\n for (var i = 0; i < keys.length; i++) {\n defineReactive$$1(obj, keys[i]);\n }\n};\n\n/**\n * Observe a list of Array items.\n */\nObserver.prototype.observeArray = function observeArray (items) {\n for (var i = 0, l = items.length; i < l; i++) {\n observe(items[i]);\n }\n};\n\n// helpers\n\n/**\n * Augment a target Object or Array by intercepting\n * the prototype chain using __proto__\n */\nfunction protoAugment (target, src) {\n /* eslint-disable no-proto */\n target.__proto__ = src;\n /* eslint-enable no-proto */\n}\n\n/**\n * Augment a target Object or Array by defining\n * hidden properties.\n */\n/* istanbul ignore next */\nfunction copyAugment (target, src, keys) {\n for (var i = 0, l = keys.length; i < l; i++) {\n var key = keys[i];\n def(target, key, src[key]);\n }\n}\n\n/**\n * Attempt to create an observer instance for a value,\n * returns the new observer if successfully observed,\n * or the existing observer if the value already has one.\n */\nfunction observe (value, asRootData) {\n if (!isObject(value) || value instanceof VNode) {\n return\n }\n var ob;\n if (hasOwn(value, '__ob__') && value.__ob__ instanceof Observer) {\n ob = value.__ob__;\n } else if (\n shouldObserve &&\n !isServerRendering() &&\n (Array.isArray(value) || isPlainObject(value)) &&\n Object.isExtensible(value) &&\n !value._isVue\n ) {\n ob = new Observer(value);\n }\n if (asRootData && ob) {\n ob.vmCount++;\n }\n return ob\n}\n\n/**\n * Define a reactive property on an Object.\n */\nfunction defineReactive$$1 (\n obj,\n key,\n val,\n customSetter,\n shallow\n) {\n var dep = new Dep();\n\n var property = Object.getOwnPropertyDescriptor(obj, key);\n if (property && property.configurable === false) {\n return\n }\n\n // cater for pre-defined getter/setters\n var getter = property && property.get;\n var setter = property && property.set;\n if ((!getter || setter) && arguments.length === 2) {\n val = obj[key];\n }\n\n var childOb = !shallow && observe(val);\n Object.defineProperty(obj, key, {\n enumerable: true,\n configurable: true,\n get: function reactiveGetter () {\n var value = getter ? getter.call(obj) : val;\n if (Dep.target) {\n dep.depend();\n if (childOb) {\n childOb.dep.depend();\n if (Array.isArray(value)) {\n dependArray(value);\n }\n }\n }\n return value\n },\n set: function reactiveSetter (newVal) {\n var value = getter ? getter.call(obj) : val;\n /* eslint-disable no-self-compare */\n if (newVal === value || (newVal !== newVal && value !== value)) {\n return\n }\n /* eslint-enable no-self-compare */\n if (process.env.NODE_ENV !== 'production' && customSetter) {\n customSetter();\n }\n // #7981: for accessor properties without setter\n if (getter && !setter) { return }\n if (setter) {\n setter.call(obj, newVal);\n } else {\n val = newVal;\n }\n childOb = !shallow && observe(newVal);\n dep.notify();\n }\n });\n}\n\n/**\n * Set a property on an object. Adds the new property and\n * triggers change notification if the property doesn't\n * already exist.\n */\nfunction set (target, key, val) {\n if (process.env.NODE_ENV !== 'production' &&\n (isUndef(target) || isPrimitive(target))\n ) {\n warn((\"Cannot set reactive property on undefined, null, or primitive value: \" + ((target))));\n }\n if (Array.isArray(target) && isValidArrayIndex(key)) {\n target.length = Math.max(target.length, key);\n target.splice(key, 1, val);\n return val\n }\n if (key in target && !(key in Object.prototype)) {\n target[key] = val;\n return val\n }\n var ob = (target).__ob__;\n if (target._isVue || (ob && ob.vmCount)) {\n process.env.NODE_ENV !== 'production' && warn(\n 'Avoid adding reactive properties to a Vue instance or its root $data ' +\n 'at runtime - declare it upfront in the data option.'\n );\n return val\n }\n if (!ob) {\n target[key] = val;\n return val\n }\n defineReactive$$1(ob.value, key, val);\n ob.dep.notify();\n return val\n}\n\n/**\n * Delete a property and trigger change if necessary.\n */\nfunction del (target, key) {\n if (process.env.NODE_ENV !== 'production' &&\n (isUndef(target) || isPrimitive(target))\n ) {\n warn((\"Cannot delete reactive property on undefined, null, or primitive value: \" + ((target))));\n }\n if (Array.isArray(target) && isValidArrayIndex(key)) {\n target.splice(key, 1);\n return\n }\n var ob = (target).__ob__;\n if (target._isVue || (ob && ob.vmCount)) {\n process.env.NODE_ENV !== 'production' && warn(\n 'Avoid deleting properties on a Vue instance or its root $data ' +\n '- just set it to null.'\n );\n return\n }\n if (!hasOwn(target, key)) {\n return\n }\n delete target[key];\n if (!ob) {\n return\n }\n ob.dep.notify();\n}\n\n/**\n * Collect dependencies on array elements when the array is touched, since\n * we cannot intercept array element access like property getters.\n */\nfunction dependArray (value) {\n for (var e = (void 0), i = 0, l = value.length; i < l; i++) {\n e = value[i];\n e && e.__ob__ && e.__ob__.dep.depend();\n if (Array.isArray(e)) {\n dependArray(e);\n }\n }\n}\n\n/* */\n\n/**\n * Option overwriting strategies are functions that handle\n * how to merge a parent option value and a child option\n * value into the final value.\n */\nvar strats = config.optionMergeStrategies;\n\n/**\n * Options with restrictions\n */\nif (process.env.NODE_ENV !== 'production') {\n strats.el = strats.propsData = function (parent, child, vm, key) {\n if (!vm) {\n warn(\n \"option \\\"\" + key + \"\\\" can only be used during instance \" +\n 'creation with the `new` keyword.'\n );\n }\n return defaultStrat(parent, child)\n };\n}\n\n/**\n * Helper that recursively merges two data objects together.\n */\nfunction mergeData (to, from) {\n if (!from) { return to }\n var key, toVal, fromVal;\n\n var keys = hasSymbol\n ? Reflect.ownKeys(from)\n : Object.keys(from);\n\n for (var i = 0; i < keys.length; i++) {\n key = keys[i];\n // in case the object is already observed...\n if (key === '__ob__') { continue }\n toVal = to[key];\n fromVal = from[key];\n if (!hasOwn(to, key)) {\n set(to, key, fromVal);\n } else if (\n toVal !== fromVal &&\n isPlainObject(toVal) &&\n isPlainObject(fromVal)\n ) {\n mergeData(toVal, fromVal);\n }\n }\n return to\n}\n\n/**\n * Data\n */\nfunction mergeDataOrFn (\n parentVal,\n childVal,\n vm\n) {\n if (!vm) {\n // in a Vue.extend merge, both should be functions\n if (!childVal) {\n return parentVal\n }\n if (!parentVal) {\n return childVal\n }\n // when parentVal & childVal are both present,\n // we need to return a function that returns the\n // merged result of both functions... no need to\n // check if parentVal is a function here because\n // it has to be a function to pass previous merges.\n return function mergedDataFn () {\n return mergeData(\n typeof childVal === 'function' ? childVal.call(this, this) : childVal,\n typeof parentVal === 'function' ? parentVal.call(this, this) : parentVal\n )\n }\n } else {\n return function mergedInstanceDataFn () {\n // instance merge\n var instanceData = typeof childVal === 'function'\n ? childVal.call(vm, vm)\n : childVal;\n var defaultData = typeof parentVal === 'function'\n ? parentVal.call(vm, vm)\n : parentVal;\n if (instanceData) {\n return mergeData(instanceData, defaultData)\n } else {\n return defaultData\n }\n }\n }\n}\n\nstrats.data = function (\n parentVal,\n childVal,\n vm\n) {\n if (!vm) {\n if (childVal && typeof childVal !== 'function') {\n process.env.NODE_ENV !== 'production' && warn(\n 'The \"data\" option should be a function ' +\n 'that returns a per-instance value in component ' +\n 'definitions.',\n vm\n );\n\n return parentVal\n }\n return mergeDataOrFn(parentVal, childVal)\n }\n\n return mergeDataOrFn(parentVal, childVal, vm)\n};\n\n/**\n * Hooks and props are merged as arrays.\n */\nfunction mergeHook (\n parentVal,\n childVal\n) {\n var res = childVal\n ? parentVal\n ? parentVal.concat(childVal)\n : Array.isArray(childVal)\n ? childVal\n : [childVal]\n : parentVal;\n return res\n ? dedupeHooks(res)\n : res\n}\n\nfunction dedupeHooks (hooks) {\n var res = [];\n for (var i = 0; i < hooks.length; i++) {\n if (res.indexOf(hooks[i]) === -1) {\n res.push(hooks[i]);\n }\n }\n return res\n}\n\nLIFECYCLE_HOOKS.forEach(function (hook) {\n strats[hook] = mergeHook;\n});\n\n/**\n * Assets\n *\n * When a vm is present (instance creation), we need to do\n * a three-way merge between constructor options, instance\n * options and parent options.\n */\nfunction mergeAssets (\n parentVal,\n childVal,\n vm,\n key\n) {\n var res = Object.create(parentVal || null);\n if (childVal) {\n process.env.NODE_ENV !== 'production' && assertObjectType(key, childVal, vm);\n return extend(res, childVal)\n } else {\n return res\n }\n}\n\nASSET_TYPES.forEach(function (type) {\n strats[type + 's'] = mergeAssets;\n});\n\n/**\n * Watchers.\n *\n * Watchers hashes should not overwrite one\n * another, so we merge them as arrays.\n */\nstrats.watch = function (\n parentVal,\n childVal,\n vm,\n key\n) {\n // work around Firefox's Object.prototype.watch...\n if (parentVal === nativeWatch) { parentVal = undefined; }\n if (childVal === nativeWatch) { childVal = undefined; }\n /* istanbul ignore if */\n if (!childVal) { return Object.create(parentVal || null) }\n if (process.env.NODE_ENV !== 'production') {\n assertObjectType(key, childVal, vm);\n }\n if (!parentVal) { return childVal }\n var ret = {};\n extend(ret, parentVal);\n for (var key$1 in childVal) {\n var parent = ret[key$1];\n var child = childVal[key$1];\n if (parent && !Array.isArray(parent)) {\n parent = [parent];\n }\n ret[key$1] = parent\n ? parent.concat(child)\n : Array.isArray(child) ? child : [child];\n }\n return ret\n};\n\n/**\n * Other object hashes.\n */\nstrats.props =\nstrats.methods =\nstrats.inject =\nstrats.computed = function (\n parentVal,\n childVal,\n vm,\n key\n) {\n if (childVal && process.env.NODE_ENV !== 'production') {\n assertObjectType(key, childVal, vm);\n }\n if (!parentVal) { return childVal }\n var ret = Object.create(null);\n extend(ret, parentVal);\n if (childVal) { extend(ret, childVal); }\n return ret\n};\nstrats.provide = mergeDataOrFn;\n\n/**\n * Default strategy.\n */\nvar defaultStrat = function (parentVal, childVal) {\n return childVal === undefined\n ? parentVal\n : childVal\n};\n\n/**\n * Validate component names\n */\nfunction checkComponents (options) {\n for (var key in options.components) {\n validateComponentName(key);\n }\n}\n\nfunction validateComponentName (name) {\n if (!new RegExp((\"^[a-zA-Z][\\\\-\\\\.0-9_\" + (unicodeRegExp.source) + \"]*$\")).test(name)) {\n warn(\n 'Invalid component name: \"' + name + '\". Component names ' +\n 'should conform to valid custom element name in html5 specification.'\n );\n }\n if (isBuiltInTag(name) || config.isReservedTag(name)) {\n warn(\n 'Do not use built-in or reserved HTML elements as component ' +\n 'id: ' + name\n );\n }\n}\n\n/**\n * Ensure all props option syntax are normalized into the\n * Object-based format.\n */\nfunction normalizeProps (options, vm) {\n var props = options.props;\n if (!props) { return }\n var res = {};\n var i, val, name;\n if (Array.isArray(props)) {\n i = props.length;\n while (i--) {\n val = props[i];\n if (typeof val === 'string') {\n name = camelize(val);\n res[name] = { type: null };\n } else if (process.env.NODE_ENV !== 'production') {\n warn('props must be strings when using array syntax.');\n }\n }\n } else if (isPlainObject(props)) {\n for (var key in props) {\n val = props[key];\n name = camelize(key);\n res[name] = isPlainObject(val)\n ? val\n : { type: val };\n }\n } else if (process.env.NODE_ENV !== 'production') {\n warn(\n \"Invalid value for option \\\"props\\\": expected an Array or an Object, \" +\n \"but got \" + (toRawType(props)) + \".\",\n vm\n );\n }\n options.props = res;\n}\n\n/**\n * Normalize all injections into Object-based format\n */\nfunction normalizeInject (options, vm) {\n var inject = options.inject;\n if (!inject) { return }\n var normalized = options.inject = {};\n if (Array.isArray(inject)) {\n for (var i = 0; i < inject.length; i++) {\n normalized[inject[i]] = { from: inject[i] };\n }\n } else if (isPlainObject(inject)) {\n for (var key in inject) {\n var val = inject[key];\n normalized[key] = isPlainObject(val)\n ? extend({ from: key }, val)\n : { from: val };\n }\n } else if (process.env.NODE_ENV !== 'production') {\n warn(\n \"Invalid value for option \\\"inject\\\": expected an Array or an Object, \" +\n \"but got \" + (toRawType(inject)) + \".\",\n vm\n );\n }\n}\n\n/**\n * Normalize raw function directives into object format.\n */\nfunction normalizeDirectives (options) {\n var dirs = options.directives;\n if (dirs) {\n for (var key in dirs) {\n var def$$1 = dirs[key];\n if (typeof def$$1 === 'function') {\n dirs[key] = { bind: def$$1, update: def$$1 };\n }\n }\n }\n}\n\nfunction assertObjectType (name, value, vm) {\n if (!isPlainObject(value)) {\n warn(\n \"Invalid value for option \\\"\" + name + \"\\\": expected an Object, \" +\n \"but got \" + (toRawType(value)) + \".\",\n vm\n );\n }\n}\n\n/**\n * Merge two option objects into a new one.\n * Core utility used in both instantiation and inheritance.\n */\nfunction mergeOptions (\n parent,\n child,\n vm\n) {\n if (process.env.NODE_ENV !== 'production') {\n checkComponents(child);\n }\n\n if (typeof child === 'function') {\n child = child.options;\n }\n\n normalizeProps(child, vm);\n normalizeInject(child, vm);\n normalizeDirectives(child);\n\n // Apply extends and mixins on the child options,\n // but only if it is a raw options object that isn't\n // the result of another mergeOptions call.\n // Only merged options has the _base property.\n if (!child._base) {\n if (child.extends) {\n parent = mergeOptions(parent, child.extends, vm);\n }\n if (child.mixins) {\n for (var i = 0, l = child.mixins.length; i < l; i++) {\n parent = mergeOptions(parent, child.mixins[i], vm);\n }\n }\n }\n\n var options = {};\n var key;\n for (key in parent) {\n mergeField(key);\n }\n for (key in child) {\n if (!hasOwn(parent, key)) {\n mergeField(key);\n }\n }\n function mergeField (key) {\n var strat = strats[key] || defaultStrat;\n options[key] = strat(parent[key], child[key], vm, key);\n }\n return options\n}\n\n/**\n * Resolve an asset.\n * This function is used because child instances need access\n * to assets defined in its ancestor chain.\n */\nfunction resolveAsset (\n options,\n type,\n id,\n warnMissing\n) {\n /* istanbul ignore if */\n if (typeof id !== 'string') {\n return\n }\n var assets = options[type];\n // check local registration variations first\n if (hasOwn(assets, id)) { return assets[id] }\n var camelizedId = camelize(id);\n if (hasOwn(assets, camelizedId)) { return assets[camelizedId] }\n var PascalCaseId = capitalize(camelizedId);\n if (hasOwn(assets, PascalCaseId)) { return assets[PascalCaseId] }\n // fallback to prototype chain\n var res = assets[id] || assets[camelizedId] || assets[PascalCaseId];\n if (process.env.NODE_ENV !== 'production' && warnMissing && !res) {\n warn(\n 'Failed to resolve ' + type.slice(0, -1) + ': ' + id,\n options\n );\n }\n return res\n}\n\n/* */\n\n\n\nfunction validateProp (\n key,\n propOptions,\n propsData,\n vm\n) {\n var prop = propOptions[key];\n var absent = !hasOwn(propsData, key);\n var value = propsData[key];\n // boolean casting\n var booleanIndex = getTypeIndex(Boolean, prop.type);\n if (booleanIndex > -1) {\n if (absent && !hasOwn(prop, 'default')) {\n value = false;\n } else if (value === '' || value === hyphenate(key)) {\n // only cast empty string / same name to boolean if\n // boolean has higher priority\n var stringIndex = getTypeIndex(String, prop.type);\n if (stringIndex < 0 || booleanIndex < stringIndex) {\n value = true;\n }\n }\n }\n // check default value\n if (value === undefined) {\n value = getPropDefaultValue(vm, prop, key);\n // since the default value is a fresh copy,\n // make sure to observe it.\n var prevShouldObserve = shouldObserve;\n toggleObserving(true);\n observe(value);\n toggleObserving(prevShouldObserve);\n }\n if (\n process.env.NODE_ENV !== 'production' &&\n // skip validation for weex recycle-list child component props\n !(false)\n ) {\n assertProp(prop, key, value, vm, absent);\n }\n return value\n}\n\n/**\n * Get the default value of a prop.\n */\nfunction getPropDefaultValue (vm, prop, key) {\n // no default, return undefined\n if (!hasOwn(prop, 'default')) {\n return undefined\n }\n var def = prop.default;\n // warn against non-factory defaults for Object & Array\n if (process.env.NODE_ENV !== 'production' && isObject(def)) {\n warn(\n 'Invalid default value for prop \"' + key + '\": ' +\n 'Props with type Object/Array must use a factory function ' +\n 'to return the default value.',\n vm\n );\n }\n // the raw prop value was also undefined from previous render,\n // return previous default value to avoid unnecessary watcher trigger\n if (vm && vm.$options.propsData &&\n vm.$options.propsData[key] === undefined &&\n vm._props[key] !== undefined\n ) {\n return vm._props[key]\n }\n // call factory function for non-Function types\n // a value is Function if its prototype is function even across different execution context\n return typeof def === 'function' && getType(prop.type) !== 'Function'\n ? def.call(vm)\n : def\n}\n\n/**\n * Assert whether a prop is valid.\n */\nfunction assertProp (\n prop,\n name,\n value,\n vm,\n absent\n) {\n if (prop.required && absent) {\n warn(\n 'Missing required prop: \"' + name + '\"',\n vm\n );\n return\n }\n if (value == null && !prop.required) {\n return\n }\n var type = prop.type;\n var valid = !type || type === true;\n var expectedTypes = [];\n if (type) {\n if (!Array.isArray(type)) {\n type = [type];\n }\n for (var i = 0; i < type.length && !valid; i++) {\n var assertedType = assertType(value, type[i]);\n expectedTypes.push(assertedType.expectedType || '');\n valid = assertedType.valid;\n }\n }\n\n if (!valid) {\n warn(\n getInvalidTypeMessage(name, value, expectedTypes),\n vm\n );\n return\n }\n var validator = prop.validator;\n if (validator) {\n if (!validator(value)) {\n warn(\n 'Invalid prop: custom validator check failed for prop \"' + name + '\".',\n vm\n );\n }\n }\n}\n\nvar simpleCheckRE = /^(String|Number|Boolean|Function|Symbol)$/;\n\nfunction assertType (value, type) {\n var valid;\n var expectedType = getType(type);\n if (simpleCheckRE.test(expectedType)) {\n var t = typeof value;\n valid = t === expectedType.toLowerCase();\n // for primitive wrapper objects\n if (!valid && t === 'object') {\n valid = value instanceof type;\n }\n } else if (expectedType === 'Object') {\n valid = isPlainObject(value);\n } else if (expectedType === 'Array') {\n valid = Array.isArray(value);\n } else {\n valid = value instanceof type;\n }\n return {\n valid: valid,\n expectedType: expectedType\n }\n}\n\n/**\n * Use function string name to check built-in types,\n * because a simple equality check will fail when running\n * across different vms / iframes.\n */\nfunction getType (fn) {\n var match = fn && fn.toString().match(/^\\s*function (\\w+)/);\n return match ? match[1] : ''\n}\n\nfunction isSameType (a, b) {\n return getType(a) === getType(b)\n}\n\nfunction getTypeIndex (type, expectedTypes) {\n if (!Array.isArray(expectedTypes)) {\n return isSameType(expectedTypes, type) ? 0 : -1\n }\n for (var i = 0, len = expectedTypes.length; i < len; i++) {\n if (isSameType(expectedTypes[i], type)) {\n return i\n }\n }\n return -1\n}\n\nfunction getInvalidTypeMessage (name, value, expectedTypes) {\n var message = \"Invalid prop: type check failed for prop \\\"\" + name + \"\\\".\" +\n \" Expected \" + (expectedTypes.map(capitalize).join(', '));\n var expectedType = expectedTypes[0];\n var receivedType = toRawType(value);\n var expectedValue = styleValue(value, expectedType);\n var receivedValue = styleValue(value, receivedType);\n // check if we need to specify expected value\n if (expectedTypes.length === 1 &&\n isExplicable(expectedType) &&\n !isBoolean(expectedType, receivedType)) {\n message += \" with value \" + expectedValue;\n }\n message += \", got \" + receivedType + \" \";\n // check if we need to specify received value\n if (isExplicable(receivedType)) {\n message += \"with value \" + receivedValue + \".\";\n }\n return message\n}\n\nfunction styleValue (value, type) {\n if (type === 'String') {\n return (\"\\\"\" + value + \"\\\"\")\n } else if (type === 'Number') {\n return (\"\" + (Number(value)))\n } else {\n return (\"\" + value)\n }\n}\n\nfunction isExplicable (value) {\n var explicitTypes = ['string', 'number', 'boolean'];\n return explicitTypes.some(function (elem) { return value.toLowerCase() === elem; })\n}\n\nfunction isBoolean () {\n var args = [], len = arguments.length;\n while ( len-- ) args[ len ] = arguments[ len ];\n\n return args.some(function (elem) { return elem.toLowerCase() === 'boolean'; })\n}\n\n/* */\n\nfunction handleError (err, vm, info) {\n // Deactivate deps tracking while processing error handler to avoid possible infinite rendering.\n // See: https://github.com/vuejs/vuex/issues/1505\n pushTarget();\n try {\n if (vm) {\n var cur = vm;\n while ((cur = cur.$parent)) {\n var hooks = cur.$options.errorCaptured;\n if (hooks) {\n for (var i = 0; i < hooks.length; i++) {\n try {\n var capture = hooks[i].call(cur, err, vm, info) === false;\n if (capture) { return }\n } catch (e) {\n globalHandleError(e, cur, 'errorCaptured hook');\n }\n }\n }\n }\n }\n globalHandleError(err, vm, info);\n } finally {\n popTarget();\n }\n}\n\nfunction invokeWithErrorHandling (\n handler,\n context,\n args,\n vm,\n info\n) {\n var res;\n try {\n res = args ? handler.apply(context, args) : handler.call(context);\n if (res && !res._isVue && isPromise(res) && !res._handled) {\n res.catch(function (e) { return handleError(e, vm, info + \" (Promise/async)\"); });\n // issue #9511\n // avoid catch triggering multiple times when nested calls\n res._handled = true;\n }\n } catch (e) {\n handleError(e, vm, info);\n }\n return res\n}\n\nfunction globalHandleError (err, vm, info) {\n if (config.errorHandler) {\n try {\n return config.errorHandler.call(null, err, vm, info)\n } catch (e) {\n // if the user intentionally throws the original error in the handler,\n // do not log it twice\n if (e !== err) {\n logError(e, null, 'config.errorHandler');\n }\n }\n }\n logError(err, vm, info);\n}\n\nfunction logError (err, vm, info) {\n if (process.env.NODE_ENV !== 'production') {\n warn((\"Error in \" + info + \": \\\"\" + (err.toString()) + \"\\\"\"), vm);\n }\n /* istanbul ignore else */\n if ((inBrowser || inWeex) && typeof console !== 'undefined') {\n console.error(err);\n } else {\n throw err\n }\n}\n\n/* */\n\nvar isUsingMicroTask = false;\n\nvar callbacks = [];\nvar pending = false;\n\nfunction flushCallbacks () {\n pending = false;\n var copies = callbacks.slice(0);\n callbacks.length = 0;\n for (var i = 0; i < copies.length; i++) {\n copies[i]();\n }\n}\n\n// Here we have async deferring wrappers using microtasks.\n// In 2.5 we used (macro) tasks (in combination with microtasks).\n// However, it has subtle problems when state is changed right before repaint\n// (e.g. #6813, out-in transitions).\n// Also, using (macro) tasks in event handler would cause some weird behaviors\n// that cannot be circumvented (e.g. #7109, #7153, #7546, #7834, #8109).\n// So we now use microtasks everywhere, again.\n// A major drawback of this tradeoff is that there are some scenarios\n// where microtasks have too high a priority and fire in between supposedly\n// sequential events (e.g. #4521, #6690, which have workarounds)\n// or even between bubbling of the same event (#6566).\nvar timerFunc;\n\n// The nextTick behavior leverages the microtask queue, which can be accessed\n// via either native Promise.then or MutationObserver.\n// MutationObserver has wider support, however it is seriously bugged in\n// UIWebView in iOS >= 9.3.3 when triggered in touch event handlers. It\n// completely stops working after triggering a few times... so, if native\n// Promise is available, we will use it:\n/* istanbul ignore next, $flow-disable-line */\nif (typeof Promise !== 'undefined' && isNative(Promise)) {\n var p = Promise.resolve();\n timerFunc = function () {\n p.then(flushCallbacks);\n // In problematic UIWebViews, Promise.then doesn't completely break, but\n // it can get stuck in a weird state where callbacks are pushed into the\n // microtask queue but the queue isn't being flushed, until the browser\n // needs to do some other work, e.g. handle a timer. Therefore we can\n // \"force\" the microtask queue to be flushed by adding an empty timer.\n if (isIOS) { setTimeout(noop); }\n };\n isUsingMicroTask = true;\n} else if (!isIE && typeof MutationObserver !== 'undefined' && (\n isNative(MutationObserver) ||\n // PhantomJS and iOS 7.x\n MutationObserver.toString() === '[object MutationObserverConstructor]'\n)) {\n // Use MutationObserver where native Promise is not available,\n // e.g. PhantomJS, iOS7, Android 4.4\n // (#6466 MutationObserver is unreliable in IE11)\n var counter = 1;\n var observer = new MutationObserver(flushCallbacks);\n var textNode = document.createTextNode(String(counter));\n observer.observe(textNode, {\n characterData: true\n });\n timerFunc = function () {\n counter = (counter + 1) % 2;\n textNode.data = String(counter);\n };\n isUsingMicroTask = true;\n} else if (typeof setImmediate !== 'undefined' && isNative(setImmediate)) {\n // Fallback to setImmediate.\n // Technically it leverages the (macro) task queue,\n // but it is still a better choice than setTimeout.\n timerFunc = function () {\n setImmediate(flushCallbacks);\n };\n} else {\n // Fallback to setTimeout.\n timerFunc = function () {\n setTimeout(flushCallbacks, 0);\n };\n}\n\nfunction nextTick (cb, ctx) {\n var _resolve;\n callbacks.push(function () {\n if (cb) {\n try {\n cb.call(ctx);\n } catch (e) {\n handleError(e, ctx, 'nextTick');\n }\n } else if (_resolve) {\n _resolve(ctx);\n }\n });\n if (!pending) {\n pending = true;\n timerFunc();\n }\n // $flow-disable-line\n if (!cb && typeof Promise !== 'undefined') {\n return new Promise(function (resolve) {\n _resolve = resolve;\n })\n }\n}\n\n/* */\n\n/* not type checking this file because flow doesn't play well with Proxy */\n\nvar initProxy;\n\nif (process.env.NODE_ENV !== 'production') {\n var allowedGlobals = makeMap(\n 'Infinity,undefined,NaN,isFinite,isNaN,' +\n 'parseFloat,parseInt,decodeURI,decodeURIComponent,encodeURI,encodeURIComponent,' +\n 'Math,Number,Date,Array,Object,Boolean,String,RegExp,Map,Set,JSON,Intl,' +\n 'require' // for Webpack/Browserify\n );\n\n var warnNonPresent = function (target, key) {\n warn(\n \"Property or method \\\"\" + key + \"\\\" is not defined on the instance but \" +\n 'referenced during render. Make sure that this property is reactive, ' +\n 'either in the data option, or for class-based components, by ' +\n 'initializing the property. ' +\n 'See: https://vuejs.org/v2/guide/reactivity.html#Declaring-Reactive-Properties.',\n target\n );\n };\n\n var warnReservedPrefix = function (target, key) {\n warn(\n \"Property \\\"\" + key + \"\\\" must be accessed with \\\"$data.\" + key + \"\\\" because \" +\n 'properties starting with \"$\" or \"_\" are not proxied in the Vue instance to ' +\n 'prevent conflicts with Vue internals. ' +\n 'See: https://vuejs.org/v2/api/#data',\n target\n );\n };\n\n var hasProxy =\n typeof Proxy !== 'undefined' && isNative(Proxy);\n\n if (hasProxy) {\n var isBuiltInModifier = makeMap('stop,prevent,self,ctrl,shift,alt,meta,exact');\n config.keyCodes = new Proxy(config.keyCodes, {\n set: function set (target, key, value) {\n if (isBuiltInModifier(key)) {\n warn((\"Avoid overwriting built-in modifier in config.keyCodes: .\" + key));\n return false\n } else {\n target[key] = value;\n return true\n }\n }\n });\n }\n\n var hasHandler = {\n has: function has (target, key) {\n var has = key in target;\n var isAllowed = allowedGlobals(key) ||\n (typeof key === 'string' && key.charAt(0) === '_' && !(key in target.$data));\n if (!has && !isAllowed) {\n if (key in target.$data) { warnReservedPrefix(target, key); }\n else { warnNonPresent(target, key); }\n }\n return has || !isAllowed\n }\n };\n\n var getHandler = {\n get: function get (target, key) {\n if (typeof key === 'string' && !(key in target)) {\n if (key in target.$data) { warnReservedPrefix(target, key); }\n else { warnNonPresent(target, key); }\n }\n return target[key]\n }\n };\n\n initProxy = function initProxy (vm) {\n if (hasProxy) {\n // determine which proxy handler to use\n var options = vm.$options;\n var handlers = options.render && options.render._withStripped\n ? getHandler\n : hasHandler;\n vm._renderProxy = new Proxy(vm, handlers);\n } else {\n vm._renderProxy = vm;\n }\n };\n}\n\n/* */\n\nvar seenObjects = new _Set();\n\n/**\n * Recursively traverse an object to evoke all converted\n * getters, so that every nested property inside the object\n * is collected as a \"deep\" dependency.\n */\nfunction traverse (val) {\n _traverse(val, seenObjects);\n seenObjects.clear();\n}\n\nfunction _traverse (val, seen) {\n var i, keys;\n var isA = Array.isArray(val);\n if ((!isA && !isObject(val)) || Object.isFrozen(val) || val instanceof VNode) {\n return\n }\n if (val.__ob__) {\n var depId = val.__ob__.dep.id;\n if (seen.has(depId)) {\n return\n }\n seen.add(depId);\n }\n if (isA) {\n i = val.length;\n while (i--) { _traverse(val[i], seen); }\n } else {\n keys = Object.keys(val);\n i = keys.length;\n while (i--) { _traverse(val[keys[i]], seen); }\n }\n}\n\nvar mark;\nvar measure;\n\nif (process.env.NODE_ENV !== 'production') {\n var perf = inBrowser && window.performance;\n /* istanbul ignore if */\n if (\n perf &&\n perf.mark &&\n perf.measure &&\n perf.clearMarks &&\n perf.clearMeasures\n ) {\n mark = function (tag) { return perf.mark(tag); };\n measure = function (name, startTag, endTag) {\n perf.measure(name, startTag, endTag);\n perf.clearMarks(startTag);\n perf.clearMarks(endTag);\n // perf.clearMeasures(name)\n };\n }\n}\n\n/* */\n\nvar normalizeEvent = cached(function (name) {\n var passive = name.charAt(0) === '&';\n name = passive ? name.slice(1) : name;\n var once$$1 = name.charAt(0) === '~'; // Prefixed last, checked first\n name = once$$1 ? name.slice(1) : name;\n var capture = name.charAt(0) === '!';\n name = capture ? name.slice(1) : name;\n return {\n name: name,\n once: once$$1,\n capture: capture,\n passive: passive\n }\n});\n\nfunction createFnInvoker (fns, vm) {\n function invoker () {\n var arguments$1 = arguments;\n\n var fns = invoker.fns;\n if (Array.isArray(fns)) {\n var cloned = fns.slice();\n for (var i = 0; i < cloned.length; i++) {\n invokeWithErrorHandling(cloned[i], null, arguments$1, vm, \"v-on handler\");\n }\n } else {\n // return handler return value for single handlers\n return invokeWithErrorHandling(fns, null, arguments, vm, \"v-on handler\")\n }\n }\n invoker.fns = fns;\n return invoker\n}\n\nfunction updateListeners (\n on,\n oldOn,\n add,\n remove$$1,\n createOnceHandler,\n vm\n) {\n var name, def$$1, cur, old, event;\n for (name in on) {\n def$$1 = cur = on[name];\n old = oldOn[name];\n event = normalizeEvent(name);\n if (isUndef(cur)) {\n process.env.NODE_ENV !== 'production' && warn(\n \"Invalid handler for event \\\"\" + (event.name) + \"\\\": got \" + String(cur),\n vm\n );\n } else if (isUndef(old)) {\n if (isUndef(cur.fns)) {\n cur = on[name] = createFnInvoker(cur, vm);\n }\n if (isTrue(event.once)) {\n cur = on[name] = createOnceHandler(event.name, cur, event.capture);\n }\n add(event.name, cur, event.capture, event.passive, event.params);\n } else if (cur !== old) {\n old.fns = cur;\n on[name] = old;\n }\n }\n for (name in oldOn) {\n if (isUndef(on[name])) {\n event = normalizeEvent(name);\n remove$$1(event.name, oldOn[name], event.capture);\n }\n }\n}\n\n/* */\n\nfunction mergeVNodeHook (def, hookKey, hook) {\n if (def instanceof VNode) {\n def = def.data.hook || (def.data.hook = {});\n }\n var invoker;\n var oldHook = def[hookKey];\n\n function wrappedHook () {\n hook.apply(this, arguments);\n // important: remove merged hook to ensure it's called only once\n // and prevent memory leak\n remove(invoker.fns, wrappedHook);\n }\n\n if (isUndef(oldHook)) {\n // no existing hook\n invoker = createFnInvoker([wrappedHook]);\n } else {\n /* istanbul ignore if */\n if (isDef(oldHook.fns) && isTrue(oldHook.merged)) {\n // already a merged invoker\n invoker = oldHook;\n invoker.fns.push(wrappedHook);\n } else {\n // existing plain hook\n invoker = createFnInvoker([oldHook, wrappedHook]);\n }\n }\n\n invoker.merged = true;\n def[hookKey] = invoker;\n}\n\n/* */\n\nfunction extractPropsFromVNodeData (\n data,\n Ctor,\n tag\n) {\n // we are only extracting raw values here.\n // validation and default values are handled in the child\n // component itself.\n var propOptions = Ctor.options.props;\n if (isUndef(propOptions)) {\n return\n }\n var res = {};\n var attrs = data.attrs;\n var props = data.props;\n if (isDef(attrs) || isDef(props)) {\n for (var key in propOptions) {\n var altKey = hyphenate(key);\n if (process.env.NODE_ENV !== 'production') {\n var keyInLowerCase = key.toLowerCase();\n if (\n key !== keyInLowerCase &&\n attrs && hasOwn(attrs, keyInLowerCase)\n ) {\n tip(\n \"Prop \\\"\" + keyInLowerCase + \"\\\" is passed to component \" +\n (formatComponentName(tag || Ctor)) + \", but the declared prop name is\" +\n \" \\\"\" + key + \"\\\". \" +\n \"Note that HTML attributes are case-insensitive and camelCased \" +\n \"props need to use their kebab-case equivalents when using in-DOM \" +\n \"templates. You should probably use \\\"\" + altKey + \"\\\" instead of \\\"\" + key + \"\\\".\"\n );\n }\n }\n checkProp(res, props, key, altKey, true) ||\n checkProp(res, attrs, key, altKey, false);\n }\n }\n return res\n}\n\nfunction checkProp (\n res,\n hash,\n key,\n altKey,\n preserve\n) {\n if (isDef(hash)) {\n if (hasOwn(hash, key)) {\n res[key] = hash[key];\n if (!preserve) {\n delete hash[key];\n }\n return true\n } else if (hasOwn(hash, altKey)) {\n res[key] = hash[altKey];\n if (!preserve) {\n delete hash[altKey];\n }\n return true\n }\n }\n return false\n}\n\n/* */\n\n// The template compiler attempts to minimize the need for normalization by\n// statically analyzing the template at compile time.\n//\n// For plain HTML markup, normalization can be completely skipped because the\n// generated render function is guaranteed to return Array. There are\n// two cases where extra normalization is needed:\n\n// 1. When the children contains components - because a functional component\n// may return an Array instead of a single root. In this case, just a simple\n// normalization is needed - if any child is an Array, we flatten the whole\n// thing with Array.prototype.concat. It is guaranteed to be only 1-level deep\n// because functional components already normalize their own children.\nfunction simpleNormalizeChildren (children) {\n for (var i = 0; i < children.length; i++) {\n if (Array.isArray(children[i])) {\n return Array.prototype.concat.apply([], children)\n }\n }\n return children\n}\n\n// 2. When the children contains constructs that always generated nested Arrays,\n// e.g.